From: Matthias Maier Date: Fri, 13 Dec 2013 23:38:38 +0000 (+0000) Subject: Cleanup: Use "DEAL_II_WITH_*" instead of legacy "DEAL_II_USE_*" X-Git-Tag: v8.2.0-rc1~1201 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=898280bca15e4f888504f2fbdfecdd16bf82f44c;p=dealii.git Cleanup: Use "DEAL_II_WITH_*" instead of legacy "DEAL_II_USE_*" git-svn-id: https://svn.dealii.org/trunk@31998 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/base/config.h.in b/deal.II/include/deal.II/base/config.h.in index 571abc27f3..6766f7c24e 100644 --- a/deal.II/include/deal.II/base/config.h.in +++ b/deal.II/include/deal.II/base/config.h.in @@ -31,9 +31,6 @@ ***********************************************/ #cmakedefine DEAL_II_WITH_64BIT_INDICES -#ifdef DEAL_II_WITH_64BIT_INDICES -# define DEAL_II_USE_LARGE_INDEX_TYPE -#endif /************************************** diff --git a/deal.II/include/deal.II/base/types.h b/deal.II/include/deal.II/base/types.h index 7d873a7e5e..4a3733da4d 100644 --- a/deal.II/include/deal.II/base/types.h +++ b/deal.II/include/deal.II/base/types.h @@ -57,7 +57,7 @@ namespace types */ const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast(-2); -#ifdef DEAL_II_USE_LARGE_INDEX_TYPE +#ifdef DEAL_II_WITH_64BIT_INDICES /** * The type used for global indices of * degrees of freedom. While in sequential @@ -152,7 +152,7 @@ namespace TrilinosWrappers { namespace types { -#ifdef DEAL_II_USE_LARGE_INDEX_TYPE +#ifdef DEAL_II_WITH_64BIT_INDICES /** * Declare type of integer used in the Epetra package of Trilinos. */ diff --git a/deal.II/include/deal.II/lac/generic_linear_algebra.h b/deal.II/include/deal.II/lac/generic_linear_algebra.h index 03baf18c74..86f9925d76 100644 --- a/deal.II/include/deal.II/lac/generic_linear_algebra.h +++ b/deal.II/include/deal.II/lac/generic_linear_algebra.h @@ -42,7 +42,7 @@ namespace LinearAlgebraDealII DEAL_II_NAMESPACE_CLOSE -#ifdef DEAL_II_USE_PETSC +#ifdef DEAL_II_WITH_PETSC #include #include @@ -125,9 +125,9 @@ namespace LinearAlgebraPETSc DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_PETSC +#endif // DEAL_II_WITH_PETSC -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS #include #include @@ -208,7 +208,7 @@ namespace LinearAlgebraTrilinos DEAL_II_NAMESPACE_CLOSE -#endif // DEAL_II_USE_TRILINOS +#endif // DEAL_II_WITH_TRILINOS diff --git a/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h b/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h index 15c8731d6c..ed72eb0060 100644 --- a/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h @@ -2942,7 +2942,7 @@ namespace TrilinosWrappers SparseMatrix::in_local_range (const size_type index) const { TrilinosWrappers::types::int_type begin, end; -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES begin = matrix->RowMap().MinMyGID(); end = matrix->RowMap().MaxMyGID()+1; #else @@ -3465,7 +3465,7 @@ namespace TrilinosWrappers SparseMatrix::size_type SparseMatrix::m () const { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES return matrix->NumGlobalRows(); #else return matrix->NumGlobalRows64(); @@ -3478,7 +3478,7 @@ namespace TrilinosWrappers SparseMatrix::size_type SparseMatrix::n () const { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES return matrix->NumGlobalCols(); #else return matrix->NumGlobalCols64(); @@ -3501,7 +3501,7 @@ namespace TrilinosWrappers SparseMatrix::local_range () const { size_type begin, end; -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES begin = matrix->RowMap().MinMyGID(); end = matrix->RowMap().MaxMyGID()+1; #else @@ -3518,7 +3518,7 @@ namespace TrilinosWrappers SparseMatrix::size_type SparseMatrix::n_nonzero_elements () const { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES return matrix->NumGlobalNonzeros(); #else return matrix->NumGlobalNonzeros64(); diff --git a/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h b/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h index 22f1ade8d0..3519bf8af1 100644 --- a/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -1626,7 +1626,7 @@ namespace TrilinosWrappers SparsityPattern::in_local_range (const size_type index) const { TrilinosWrappers::types::int_type begin, end; -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES begin = graph->RowMap().MinMyGID(); end = graph->RowMap().MaxMyGID()+1; #else diff --git a/deal.II/include/deal.II/lac/trilinos_vector.h b/deal.II/include/deal.II/lac/trilinos_vector.h index d8b651925b..1c4762e18c 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector.h +++ b/deal.II/include/deal.II/lac/trilinos_vector.h @@ -49,7 +49,7 @@ namespace TrilinosWrappers namespace { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES // define a helper function that queries the global ID of local ID of // an Epetra_BlockMap object by calling either the 32- or 64-bit // function necessary. diff --git a/deal.II/include/deal.II/lac/trilinos_vector_base.h b/deal.II/include/deal.II/lac/trilinos_vector_base.h index 848a8ad556..66995f19cd 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector_base.h +++ b/deal.II/include/deal.II/lac/trilinos_vector_base.h @@ -1296,7 +1296,7 @@ namespace TrilinosWrappers else if (vector->Map().NumMyElements() > 0) { const size_type n_indices = vector->Map().NumMyElements(); -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES unsigned int *vector_indices = (unsigned int *)vector->Map().MyGlobalElements(); #else size_type *vector_indices = (size_type *)vector->Map().MyGlobalElements64(); @@ -1661,7 +1661,7 @@ namespace TrilinosWrappers VectorBase::size_type VectorBase::size () const { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES return (size_type) (vector->Map().MaxAllGID() + 1 - vector->Map().MinAllGID()); #else return (size_type) (vector->Map().MaxAllGID64() + 1 - vector->Map().MinAllGID64()); @@ -1683,7 +1683,7 @@ namespace TrilinosWrappers std::pair VectorBase::local_range () const { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES const TrilinosWrappers::types::int_type begin = vector->Map().MinMyGID(); const TrilinosWrappers::types::int_type end = vector->Map().MaxMyGID()+1; #else diff --git a/deal.II/include/deal.II/lac/vector.templates.h b/deal.II/include/deal.II/lac/vector.templates.h index 91529fd539..3f64f3e5ce 100644 --- a/deal.II/include/deal.II/lac/vector.templates.h +++ b/deal.II/include/deal.II/lac/vector.templates.h @@ -1393,7 +1393,7 @@ void Vector::block_write (std::ostream &out) const const size_type sz = size(); char buf[16]; -#ifdef DEAL_II_USE_LARGE_INDEX_TYPE +#ifdef DEAL_II_WITH_64BIT_INDICES std::sprintf(buf, "%llu", sz); #else std::sprintf(buf, "%u", sz); diff --git a/deal.II/source/fe/fe_tools_interpolate.cc b/deal.II/source/fe/fe_tools_interpolate.cc index eee88ee74b..13a0dace97 100644 --- a/deal.II/source/fe/fe_tools_interpolate.cc +++ b/deal.II/source/fe/fe_tools_interpolate.cc @@ -461,7 +461,7 @@ namespace FETools #endif // special version for Trilinos -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template void back_interpolate (const DoFHandler &dof1, const ConstraintMatrix &constraints1, @@ -644,7 +644,7 @@ namespace FETools } // special version for Trilinos -#ifdef DEAL_II_USE_TRILINOS +#ifdef DEAL_II_WITH_TRILINOS template void interpolation_difference (const DoFHandler &dof1, const ConstraintMatrix &constraints1, diff --git a/deal.II/source/lac/constraint_matrix.cc b/deal.II/source/lac/constraint_matrix.cc index 493b3f7c16..6c8cdbc796 100644 --- a/deal.II/source/lac/constraint_matrix.cc +++ b/deal.II/source/lac/constraint_matrix.cc @@ -651,7 +651,7 @@ void ConstraintMatrix::condense (const SparsityPattern &uncondensed, // store for each line of the matrix its new line number after // compression. If the shift is -1, this line will be condensed away -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES std::vector new_line; #else std::vector new_line; diff --git a/deal.II/source/lac/trilinos_block_vector.cc b/deal.II/source/lac/trilinos_block_vector.cc index a0f645a3fe..4f21ce6136 100644 --- a/deal.II/source/lac/trilinos_block_vector.cc +++ b/deal.II/source/lac/trilinos_block_vector.cc @@ -31,7 +31,7 @@ namespace TrilinosWrappers // by calling either the 32- or 64-bit function necessary, and returns the // result in the correct data type so that we can use it in calling other // Epetra member functions that are overloaded by index type -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES int n_global_elements (const Epetra_BlockMap &map) { return map.NumGlobalElements(); diff --git a/deal.II/source/lac/trilinos_precondition.cc b/deal.II/source/lac/trilinos_precondition.cc index d939607b0c..db67419c43 100644 --- a/deal.II/source/lac/trilinos_precondition.cc +++ b/deal.II/source/lac/trilinos_precondition.cc @@ -36,7 +36,7 @@ namespace TrilinosWrappers { namespace { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES int global_length (const Epetra_MultiVector &vector) { return vector.GlobalLength(); diff --git a/deal.II/source/lac/trilinos_sparse_matrix.cc b/deal.II/source/lac/trilinos_sparse_matrix.cc index 8423493505..b8f2956a74 100644 --- a/deal.II/source/lac/trilinos_sparse_matrix.cc +++ b/deal.II/source/lac/trilinos_sparse_matrix.cc @@ -36,7 +36,7 @@ namespace TrilinosWrappers { namespace { -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES // define a helper function that queries the size of an Epetra_Map object // by calling either the 32- or 64-bit function necessary, and returns the // result in the correct data type so that we can use it in calling other @@ -1040,7 +1040,7 @@ namespace TrilinosWrappers const VectorBase &V, const bool transpose_left) { -#ifdef DEAL_II_USE_LARGE_INDEX_TYPE +#ifdef DEAL_II_WITH_64BIT_INDICES Assert(false,ExcNotImplemented()) #endif const bool use_vector = (V.size() == inputright.m() ? true : false); @@ -1132,7 +1132,7 @@ namespace TrilinosWrappers inputleft.trilinos_sparsity_pattern().ExtractMyRowView(i, num_entries, indices); Assert (num_entries >= 0, ExcInternalError()); -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES const size_type GID = inputleft.row_partitioner().GID(i); for (TrilinosWrappers::types::int_type j=0; j= 0, ExcInternalError()); -#ifndef DEAL_II_USE_LARGE_INDEX_TYPE +#ifndef DEAL_II_WITH_64BIT_INDICES const size_type GID = inputleft.row_partitioner().GID(i); for (TrilinosWrappers::types::int_type j=0; j