]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Cleanup: Use "DEAL_II_WITH_*" instead of legacy "DEAL_II_USE_*"
authormaier <maier@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 Dec 2013 23:38:38 +0000 (23:38 +0000)
committermaier <maier@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 Dec 2013 23:38:38 +0000 (23:38 +0000)
git-svn-id: https://svn.dealii.org/trunk@31998 0785d39b-7218-0410-832d-ea1e28bc413d

16 files changed:
deal.II/include/deal.II/base/config.h.in
deal.II/include/deal.II/base/types.h
deal.II/include/deal.II/lac/generic_linear_algebra.h
deal.II/include/deal.II/lac/trilinos_sparse_matrix.h
deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h
deal.II/include/deal.II/lac/trilinos_vector.h
deal.II/include/deal.II/lac/trilinos_vector_base.h
deal.II/include/deal.II/lac/vector.templates.h
deal.II/source/fe/fe_tools_interpolate.cc
deal.II/source/lac/constraint_matrix.cc
deal.II/source/lac/trilinos_block_vector.cc
deal.II/source/lac/trilinos_precondition.cc
deal.II/source/lac/trilinos_sparse_matrix.cc
deal.II/source/lac/trilinos_sparsity_pattern.cc
deal.II/source/lac/trilinos_vector.cc
deal.II/source/lac/trilinos_vector_base.cc

index 571abc27f341370290ccc016032ab80fab3f2fd5..6766f7c24eb260c7bbdd1c0048fd73e7674df057 100644 (file)
@@ -31,9 +31,6 @@
  ***********************************************/
 
 #cmakedefine DEAL_II_WITH_64BIT_INDICES
-#ifdef DEAL_II_WITH_64BIT_INDICES
-#  define DEAL_II_USE_LARGE_INDEX_TYPE
-#endif
 
 
 /**************************************
index 7d873a7e5ecf874dbab3b0096f64e8e9c1ea4059..4a3733da4d5ac2d2071558a3ce59a99644814ad4 100644 (file)
@@ -57,7 +57,7 @@ namespace types
    */
   const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast<subdomain_id>(-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.
      */
index 03baf18c74ba464fc85a0c2f1f3a655b3f754048..86f9925d76925f57de23ee6d85bc64f23f27d78b 100644 (file)
@@ -42,7 +42,7 @@ namespace LinearAlgebraDealII
 DEAL_II_NAMESPACE_CLOSE
 
 
-#ifdef DEAL_II_USE_PETSC
+#ifdef DEAL_II_WITH_PETSC
 
 #include <deal.II/lac/block_sparsity_pattern.h>
 #include <deal.II/lac/petsc_vector.h>
@@ -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 <deal.II/lac/trilinos_vector.h>
 #include <deal.II/lac/trilinos_block_vector.h>
@@ -208,7 +208,7 @@ namespace LinearAlgebraTrilinos
 DEAL_II_NAMESPACE_CLOSE
 
 
-#endif // DEAL_II_USE_TRILINOS
+#endif // DEAL_II_WITH_TRILINOS
 
 
 
index 15c8731d6cfd11c8cb7a083ad5b2a07739699c95..ed72eb0060b676f8321a94f489ab69697ec81c9b 100644 (file)
@@ -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();
index 22f1ade8d0bb6d8336722977120a319d65d16394..3519bf8af1810c6fd0cec3658342afec3dbd748f 100644 (file)
@@ -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
index d8b651925b4c0f0bfd7cad1b61b5572a641e99ed..1c4762e18cd6a0e4b9eb063c96d073ef65bb7558 100644 (file)
@@ -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.
index 848a8ad556a8ee65b418809c3fe6ff95b93d71d3..66995f19cdc04203431d936c21129d4340f30e0e 100644 (file)
@@ -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::size_type, VectorBase::size_type>
   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
index 91529fd539f745c05695b49a266ecd623fd58a51..3f64f3e5ce2ef824a47a16266cca39990ee73e83 100644 (file)
@@ -1393,7 +1393,7 @@ void Vector<Number>::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);
index eee88ee74bea2db7f6b67899fea6c7b01ffb2340..13a0dace97e286d2e3cf3c2adc2d706a7f19d6b0 100644 (file)
@@ -461,7 +461,7 @@ namespace FETools
 #endif
 
       // special version for Trilinos
-#ifdef DEAL_II_USE_TRILINOS
+#ifdef DEAL_II_WITH_TRILINOS
       template <int dim, int spacedim>
       void back_interpolate (const DoFHandler<dim,spacedim> &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 <int dim, int spacedim>
       void interpolation_difference (const DoFHandler<dim,spacedim> &dof1,
                                      const ConstraintMatrix &constraints1,
index 493b3f7c1651c2cc68b10688189fe67339f7e5de..6c8cdbc796c718dad90d331e4d4c544430ee2faf 100644 (file)
@@ -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<int> new_line;
 #else
   std::vector<long long int> new_line;
index a0f645a3fe298bc7beb0a312f7593a6edf24946d..4f21ce6136401bba2f25f5d8bba86e8c2fcde249 100644 (file)
@@ -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();
index d939607b0c36e64e8641b0a3e7eb9bea5159aeb8..db67419c435f2843d03554be96e634ac5b5615c0 100644 (file)
@@ -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();
index 84234935054057cc9398c1617939eee18e8bff9d..b8f2956a7449951f5d7c4577eab2d6774f88bf1e 100644 (file)
@@ -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<num_entries; ++j)
                 sparsity_transposed.add (inputleft.col_partitioner().GID(indices[j]),
@@ -1154,7 +1154,7 @@ namespace TrilinosWrappers
               inputleft.trilinos_matrix().ExtractMyRowView(i, num_entries,
                                                            values, 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<num_entries; ++j)
                 transposed_mat.set (inputleft.col_partitioner().GID(indices[j]),
@@ -1257,7 +1257,7 @@ namespace TrilinosWrappers
                        const SparseMatrix &B,
                        const VectorBase   &V) const
   {
-#ifdef DEAL_II_USE_LARGE_INDEX_TYPE
+#ifdef DEAL_II_WITH_64BIT_INDICES
     Assert(false,ExcNotImplemented())
 #endif
     internals::perform_mmult (*this, B, C, V, false);
@@ -1270,7 +1270,7 @@ namespace TrilinosWrappers
                         const SparseMatrix &B,
                         const VectorBase   &V) const
   {
-#ifdef DEAL_II_USE_LARGE_INDEX_TYPE
+#ifdef DEAL_II_WITH_64BIT_INDICES
     Assert(false,ExcNotImplemented())
 #endif
     internals::perform_mmult (*this, B, C, V, true);
index 92d0789b741383b8678f617d46c39232b38737e2..24f46180920d18e70bafe2660aa59e08a80f01ab 100644 (file)
@@ -34,7 +34,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();
index a8b026528742bb80f75cbf29cdcaaeb0c01a5fd5..ea330e88e3a893acd1fb2254a17b809a41cc7ae5 100644 (file)
@@ -32,7 +32,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_BlockMap 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
index a04d816612af0f0fa549b30d1a36cf7664d98b04..48b0afcd0cef06b832a5e7062513aa82c5c6d615 100644 (file)
@@ -29,7 +29,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 vector length of an
     // Epetra_FEVector object  by calling either the 32- or 64-bit
     // function necessary.

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.