]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix source
authorDaniel Arndt <arndtd@ornl.gov>
Fri, 17 Apr 2020 21:46:05 +0000 (17:46 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Fri, 17 Apr 2020 21:46:05 +0000 (17:46 -0400)
21 files changed:
source/base/index_set.cc
source/differentiation/ad/ad_drivers.cc
source/differentiation/sd/symengine_scalar_operations.cc
source/differentiation/sd/symengine_tensor_operations.cc
source/differentiation/sd/symengine_utilities.cc
source/grid/tria_objects.cc
source/lac/block_sparsity_pattern.cc
source/lac/petsc_matrix_base.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_sparse_matrix.cc
source/lac/petsc_vector_base.cc
source/lac/read_write_vector.cc
source/lac/sparsity_pattern.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_precondition.cc
source/lac/trilinos_precondition_ml.cc
source/lac/trilinos_precondition_muelu.cc
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_vector.cc
source/lac/vector.cc
source/numerics/time_dependent.cc

index 089fd80b7f6702ae8d104e3dfb9130c89db59073..55524adf7ca176694676c455df51b68a34a1fcd7 100644 (file)
@@ -159,6 +159,7 @@ IndexSet::do_compress() const
 
 
 
+#ifndef DOXYGEN
 IndexSet IndexSet::operator&(const IndexSet &is) const
 {
   Assert(size() == is.size(), ExcDimensionMismatch(size(), is.size()));
@@ -202,6 +203,7 @@ IndexSet IndexSet::operator&(const IndexSet &is) const
   result.compress();
   return result;
 }
+#endif
 
 
 
index fe3e85e4e04cb2a807af03167dd34a51f968929e..fe937fd23e0d2bed79adc269eb30811012c58464 100644 (file)
@@ -256,6 +256,7 @@ namespace Differentiation
 
 #  ifdef DEAL_II_WITH_ADOLC
 
+#    ifndef DOXYGEN
     // Specialization for taped ADOL-C auto-differentiable numbers.
 
     template <typename ADNumberType>
@@ -273,6 +274,7 @@ namespace Differentiation
       , vbufsize(0u)
       , tbufsize(0u)
     {}
+#    endif
 
 
     template <typename ADNumberType>
@@ -1464,6 +1466,7 @@ namespace Differentiation
     }
 
 
+#  ifndef DOXYGEN
     template <typename ADNumberType>
     std::vector<double>
     TapedDrivers<
@@ -1477,6 +1480,7 @@ namespace Differentiation
       std::copy(in.begin(), in.end(), out.begin());
       return out;
     }
+#  endif
 
 
     // -------------   TapelessDrivers   -------------
@@ -1715,6 +1719,7 @@ namespace Differentiation
     // reverse mode to compute the first derivatives (and, if supported,
     // forward mode for the second).
 
+#  ifndef DOXYGEN
     template <typename ADNumberType, typename ScalarType>
     TapelessDrivers<
       ADNumberType,
@@ -1725,6 +1730,7 @@ namespace Differentiation
           NumberTypes::sacado_rad_dfad>::type>::TapelessDrivers()
       : dependent_variable_marking_safe(false)
     {}
+#  endif
 
 
     template <typename ADNumberType, typename ScalarType>
@@ -1983,6 +1989,7 @@ namespace Differentiation
     // forward mode to compute the first (and, if supported, second)
     // derivatives.
 
+#  ifndef DOXYGEN
     template <typename ADNumberType, typename ScalarType>
     TapelessDrivers<
       ADNumberType,
@@ -1995,6 +2002,7 @@ namespace Differentiation
           NumberTypes::sacado_dfad_dfad>::type>::TapelessDrivers()
       : dependent_variable_marking_safe(false)
     {}
+#  endif
 
 
     template <typename ADNumberType, typename ScalarType>
index 33a5069f0f48004386f5f9ed4ccebf5360696a3b..aaec10c781f12e5c231eb67652309004a4d97bdb 100644 (file)
@@ -74,6 +74,7 @@ namespace Differentiation
     /* ---------------- Symbol map creation and manipulation --------------*/
 
 
+#  ifndef DOXYGEN
     namespace internal
     {
       bool
@@ -161,6 +162,7 @@ namespace Differentiation
       for (const auto &entry : symbol_values)
         set_value_in_symbol_map(substitution_map, entry.first, entry.second);
     }
+#  endif
 
 
     /* ------------------ Symbol substitution map creation ----------------*/
@@ -175,6 +177,7 @@ namespace Differentiation
     }
 
 
+#  ifndef DOXYGEN
     /* ---------------- Symbolic substitution map enlargement --------------*/
 
 
@@ -260,6 +263,7 @@ namespace Differentiation
     {
       return expression.substitute(substitution_map);
     }
+#  endif // DOXYGEN
 
   } // namespace SD
 } // namespace Differentiation
index 0cfce17dcddb8f2c44eec3a1c36b047bac4287f0..3abe49924f9a43a209ea432930d3b63030043455 100644 (file)
@@ -240,6 +240,7 @@ namespace Differentiation
     }
 
 
+#  ifndef DOXYGEN
     template <int dim>
     Tensor<1, dim, Expression>
     make_vector_of_symbolic_functions(const std::string &            sym,
@@ -247,6 +248,7 @@ namespace Differentiation
     {
       return internal::Symbol_Function_Tensor<1, dim>::create(sym, arguments);
     }
+#  endif
 
 
     template <int rank, int dim>
@@ -265,6 +267,7 @@ namespace Differentiation
     }
 
 
+#  ifndef DOXYGEN
     template <int rank, int dim>
     Tensor<rank, dim, Expression>
     make_tensor_of_symbolic_functions(const std::string &            sym,
@@ -284,6 +287,7 @@ namespace Differentiation
       return internal::Symbol_Function_SymmetricTensor<rank, dim>::create(
         sym, arguments);
     }
+#  endif // DOXYGEN
 
   } // namespace SD
 } // namespace Differentiation
index d7fed2e219046ca3eb44193ad8f1255dbbbd1a72..9bf37986081379f64053b7507d6a6b69392afa7e 100644 (file)
@@ -30,6 +30,7 @@ namespace Differentiation
 
     namespace Utilities
     {
+#  ifndef DOXYGEN
       SE::map_basic_basic
       convert_expression_map_to_basic_map(
         const SD::types::substitution_map &substitution_map)
@@ -39,6 +40,7 @@ namespace Differentiation
           sub_map[entry.first.get_RCP()] = entry.second.get_RCP();
         return sub_map;
       }
+#  endif
 
 
       SE::vec_basic
@@ -53,6 +55,7 @@ namespace Differentiation
       }
 
 
+#  ifndef DOXYGEN
       SD::types::symbol_vector
       extract_symbols(const SD::types::substitution_map &substitution_values)
       {
@@ -64,6 +67,7 @@ namespace Differentiation
 
         return symbols;
       }
+#  endif
 
     } // namespace Utilities
 
index 6e583bf96769daf38d1aab120e7a357ed444e40f..914f13806d4334c645ae62cf0edb7089dd20befd 100644 (file)
@@ -454,10 +454,12 @@ namespace internal
 
 
     // explicit instantiations
+#ifndef DOXYGEN
     template class TriaObjects<TriaObject<1>>;
     template class TriaObjects<TriaObject<2>>;
 
-#include "tria_objects.inst"
+#  include "tria_objects.inst"
+#endif
   } // namespace TriangulationImplementation
 } // namespace internal
 
index f7b21935ef58a1ace128ae65c4961f384a991a4d..2ffc8a7c23f9c8d2caf552491aa4f96746224a43 100644 (file)
@@ -273,6 +273,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::print(std::ostream &out) const
 }
 
 
+#ifndef DOXYGEN
 template <>
 void
 BlockSparsityPatternBase<DynamicSparsityPattern>::print(std::ostream &out) const
@@ -299,6 +300,7 @@ BlockSparsityPatternBase<DynamicSparsityPattern>::print(std::ostream &out) const
       k += block(ib, 0).n_rows();
     }
 }
+#endif
 
 
 template <class SparsityPatternBase>
index 45d8e54ab689d6170dafd11cd9ff27ec211b5d2e..e904755d2b28900288f59f8b8278cc6f95cd5186 100644 (file)
@@ -29,6 +29,7 @@ namespace PETScWrappers
 {
   namespace MatrixIterators
   {
+#  ifndef DOXYGEN
     void
     MatrixBase::const_iterator::Accessor::visit_present_row()
     {
@@ -68,6 +69,7 @@ namespace PETScWrappers
       ierr = MatRestoreRow(*matrix, this->a_row, &ncols, &colnums, &values);
       AssertThrow(ierr == 0, ExcPETScError(ierr));
     }
+#  endif
   } // namespace MatrixIterators
 
 
index 22c7dd1bae57e0bfc018e515703c3c6e271ddca3..3af36ce1c084fc911981c8e37219b1c29dfbf220 100644 (file)
@@ -607,6 +607,7 @@ namespace PETScWrappers
         }
     }
 
+#  ifndef DOXYGEN
     // explicit instantiations
     //
     template SparseMatrix::SparseMatrix(const MPI_Comm &,
@@ -671,6 +672,7 @@ namespace PETScWrappers
     SparseMatrix::do_reinit(const IndexSet &,
                             const IndexSet &,
                             const DynamicSparsityPattern &);
+#  endif
 
 
     PetscScalar
index 43339dbfa76565aec933447618e13c8c4cf1d581..c3ffb4cda16291ff7ae013228d06ca47635ef506 100644 (file)
@@ -286,6 +286,7 @@ namespace PETScWrappers
     MatrixBase::Tmmult(C, B, V);
   }
 
+#  ifndef DOXYGEN
   // Explicit instantiations
   //
   template SparseMatrix::SparseMatrix(const SparsityPattern &, const bool);
@@ -301,6 +302,7 @@ namespace PETScWrappers
   SparseMatrix::do_reinit(const SparsityPattern &, const bool);
   template void
   SparseMatrix::do_reinit(const DynamicSparsityPattern &, const bool);
+#  endif
 } // namespace PETScWrappers
 
 
index 328af05d321205012e5f77aeb7530e71aebc5ae3..bf041f291dc1fd6d0840d6a4767b097e79d4a7a2 100644 (file)
@@ -32,6 +32,7 @@ namespace PETScWrappers
 {
   namespace internal
   {
+#  ifndef DOXYGEN
     VectorReference::operator PetscScalar() const
     {
       AssertIndexRange(index, vector.size());
@@ -109,6 +110,7 @@ namespace PETScWrappers
 
       return value;
     }
+#  endif
   } // namespace internal
 
   VectorBase::VectorBase()
index a40c0e4e43ca5f2257fc942f55ea13b874d72f88..66fd754fc66dd86f70c02e7ae3fe99a5e5a189d8 100644 (file)
@@ -40,6 +40,7 @@ namespace LinearAlgebra
 
 #undef TEMPL_COPY_CONSTRUCTOR
 
+#ifndef DOXYGEN
   template void
   ReadWriteVector<float>::import(
     const distributed::Vector<float, ::dealii::MemorySpace::Host> &,
@@ -51,7 +52,7 @@ namespace LinearAlgebra
     const distributed::Vector<double, ::dealii::MemorySpace::Host> &,
     VectorOperation::values,
     const std::shared_ptr<const CommunicationPatternBase> &);
-#ifdef DEAL_II_WITH_COMPLEX_VALUES
+#  ifdef DEAL_II_WITH_COMPLEX_VALUES
   template void
   ReadWriteVector<std::complex<float>>::import(
     const distributed::Vector<std::complex<float>, ::dealii::MemorySpace::Host>
@@ -65,6 +66,7 @@ namespace LinearAlgebra
       &,
     VectorOperation::values,
     const std::shared_ptr<const CommunicationPatternBase> &);
+#  endif
 #endif
 } // namespace LinearAlgebra
 
index a47a6e04a0743c0a7d9b223be86f9a108bba1673..7aceed174cdd1449e69c651cebb2c0c95650e8c2 100644 (file)
@@ -1043,6 +1043,7 @@ SparsityPattern::memory_consumption() const
 
 
 
+#ifndef DOXYGEN
 // explicit instantiations
 template void
 SparsityPattern::copy_from<float>(const FullMatrix<float> &);
@@ -1055,7 +1056,7 @@ SparsityPattern::add_entries<const SparsityPattern::size_type *>(
   const size_type *,
   const size_type *,
   const bool);
-#ifndef DEAL_II_VECTOR_ITERATOR_IS_POINTER
+#  ifndef DEAL_II_VECTOR_ITERATOR_IS_POINTER
 template void
 SparsityPattern::add_entries<
   std::vector<SparsityPattern::size_type>::const_iterator>(
@@ -1063,12 +1064,13 @@ SparsityPattern::add_entries<
   std::vector<size_type>::const_iterator,
   std::vector<size_type>::const_iterator,
   const bool);
-#endif
+#  endif
 template void
 SparsityPattern::add_entries<std::vector<SparsityPattern::size_type>::iterator>(
   const size_type,
   std::vector<size_type>::iterator,
   std::vector<size_type>::iterator,
   const bool);
+#endif
 
 DEAL_II_NAMESPACE_CLOSE
index 39c9e763da97285a7cddf88ea236edebee6f2707..6c0f5b55acc2f79d3d163ce403e5494c7999d2f0 100644 (file)
@@ -38,6 +38,7 @@ namespace TrilinosWrappers
 
 
 
+#  ifndef DOXYGEN
   void
   BlockSparseMatrix::reinit(const size_type n_block_rows,
                             const size_type n_block_columns)
@@ -63,6 +64,7 @@ namespace TrilinosWrappers
           this->sub_objects[r][c] = p;
         }
   }
+#  endif
 
 
 
@@ -366,6 +368,7 @@ namespace TrilinosWrappers
 
 
 
+#  ifndef DOXYGEN
   // -------------------- explicit instantiations -----------------------
   //
   template void
@@ -387,6 +390,7 @@ namespace TrilinosWrappers
                             const dealii::BlockDynamicSparsityPattern &,
                             const MPI_Comm &,
                             const bool);
+#  endif // DOXYGEN
 
 } // namespace TrilinosWrappers
 
index b8512ae3ad40527ddc903261ee4455a72e44c89d..9cf2f2ca94146515e7218ee2c8e38c4cc822d480 100644 (file)
@@ -788,6 +788,7 @@ namespace TrilinosWrappers
     dst = src;
   }
 
+#  ifndef DOXYGEN
   void
   PreconditionIdentity::vmult(
     LinearAlgebra::distributed::Vector<double> &      dst,
@@ -803,6 +804,7 @@ namespace TrilinosWrappers
   {
     dst = src;
   }
+#  endif // DOXYGEN
 } // namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
index efa499f45b7091871eb59d0664b5d2ae95275fac..38855b134617f02767291c60656389efb9202823 100644 (file)
@@ -339,6 +339,7 @@ namespace TrilinosWrappers
 
 
 
+#  ifndef DOXYGEN
   // explicit instantiations
   template void
   PreconditionAMG::initialize(const ::dealii::SparseMatrix<double> &,
@@ -350,6 +351,7 @@ namespace TrilinosWrappers
                               const AdditionalData &,
                               const double,
                               const ::dealii::SparsityPattern *);
+#  endif
 
 
 
index 55f0b78f169054cdd47af54006bd3b77544671c2..ed1ae4ee589ebb7194549700dfbb5f80c5a5e545 100644 (file)
@@ -259,6 +259,7 @@ namespace TrilinosWrappers
 
 
 
+#    ifndef DOXYGEN
   // explicit instantiations
   template void
   PreconditionAMGMueLu::initialize(const ::dealii::SparseMatrix<double> &,
@@ -270,6 +271,7 @@ namespace TrilinosWrappers
                                    const AdditionalData &,
                                    const double,
                                    const ::dealii::SparsityPattern *);
+#    endif
 
 } // namespace TrilinosWrappers
 
index 968631b477f14fbac11e36cba569c4e1d742603e..290bfa848e68fc08edc2cb0bddf216d4b76ac06a 100644 (file)
@@ -1192,6 +1192,7 @@ namespace TrilinosWrappers
   }
 
 
+#  ifndef DOXYGEN
   // explicit instantiations
   //
   template void
@@ -1245,6 +1246,7 @@ namespace TrilinosWrappers
                           const dealii::DynamicSparsityPattern &,
                           const MPI_Comm &,
                           bool);
+#  endif
 
 } // namespace TrilinosWrappers
 
index bcf72804de51031d8737800079d2b1c4db44d4e0..408f32af22cfeb0e9dd4240675bd8c838f103d0a 100644 (file)
@@ -38,6 +38,7 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace TrilinosWrappers
 {
+#  ifndef DOXYGEN
   namespace internal
   {
     VectorReference::operator TrilinosScalar() const
@@ -62,6 +63,7 @@ namespace TrilinosWrappers
       return (*(vector.vector))[0][local_index];
     }
   } // namespace internal
+#  endif
 
   namespace MPI
   {
@@ -882,15 +884,12 @@ namespace TrilinosWrappers
              this->local_size() *
                (sizeof(double) + sizeof(TrilinosWrappers::types::int_type));
     }
-  } /* end of namespace MPI */
-} /* end of namespace TrilinosWrappers */
 
-namespace TrilinosWrappers
-{
-  namespace MPI
-  {
-#  include "trilinos_vector.inst"
-  }
+    // explicit instantiations
+#  ifndef DOXYGEN
+#    include "trilinos_vector.inst"
+#  endif
+  } // namespace MPI
 } // namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
index c747e14c22c4309ad63934df8e0d1d625d124344..10267c097656248502dfc131685deb48e8f83dba 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-#include "vector.inst"
+#ifndef DOXYGEN
+#  include "vector.inst"
 
-#ifndef DEAL_II_WITH_COMPLEX_VALUES
+#  ifndef DEAL_II_WITH_COMPLEX_VALUES
 // instantiate for std::complex<double> since we are using it internally in
 // FESeries.
 template class Vector<std::complex<double>>;
-#endif
+#  endif
 
 // instantiate for integers:
 template class Vector<int>;
@@ -44,36 +45,36 @@ template long double Vector<long double>::
 // arguments is covered by the default copy constructor and copy operator that
 // is declared separately)
 
-#define TEMPL_COPY_CONSTRUCTOR(S1, S2)             \
-  template Vector<S1>::Vector(const Vector<S2> &); \
-  template Vector<S1> &Vector<S1>::operator=<S2>(const Vector<S2> &)
+#  define TEMPL_COPY_CONSTRUCTOR(S1, S2)             \
+    template Vector<S1>::Vector(const Vector<S2> &); \
+    template Vector<S1> &Vector<S1>::operator=<S2>(const Vector<S2> &)
 
 TEMPL_COPY_CONSTRUCTOR(double, float);
 TEMPL_COPY_CONSTRUCTOR(float, double);
 
-#ifdef DEAL_II_WITH_COMPLEX_VALUES
+#  ifdef DEAL_II_WITH_COMPLEX_VALUES
 TEMPL_COPY_CONSTRUCTOR(std::complex<double>, std::complex<float>);
 TEMPL_COPY_CONSTRUCTOR(std::complex<float>, std::complex<double>);
-#endif
+#  endif
 
-#undef TEMPL_COPY_CONSTRUCTOR
+#  undef TEMPL_COPY_CONSTRUCTOR
 
 
-#define TEMPL_OP_EQ(S1, S2)                            \
-  template void Vector<S1>::scale(const Vector<S2> &); \
-  template void Vector<S1>::equ(const S1, const Vector<S2> &)
+#  define TEMPL_OP_EQ(S1, S2)                            \
+    template void Vector<S1>::scale(const Vector<S2> &); \
+    template void Vector<S1>::equ(const S1, const Vector<S2> &)
 
 TEMPL_OP_EQ(double, float);
 TEMPL_OP_EQ(float, double);
 
 
-#ifdef DEAL_II_WITH_COMPLEX_VALUES
+#  ifdef DEAL_II_WITH_COMPLEX_VALUES
 TEMPL_OP_EQ(std::complex<double>, std::complex<float>);
 TEMPL_OP_EQ(std::complex<float>, std::complex<double>);
-#endif
-
-#undef TEMPL_OP_EQ
+#  endif
 
+#  undef TEMPL_OP_EQ
+#endif
 
 
 template <>
index d58f5e8e72a8d8822696f2d5fe52025a684bca3d..0a8f7331bfa7ac3a3bedf9b8e175a827f4180942 100644 (file)
@@ -432,6 +432,7 @@ TimeStepBase_Tria<dim>::TimeStepBase_Tria()
 
 
 
+#ifndef DOXYGEN
 template <int dim>
 TimeStepBase_Tria<dim>::TimeStepBase_Tria(
   const double              time,
@@ -444,6 +445,7 @@ TimeStepBase_Tria<dim>::TimeStepBase_Tria(
   , flags(flags)
   , refinement_flags(refinement_flags)
 {}
+#endif
 
 
 

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.