From 17b2b459568e95815fe770a6622726ecc800a100 Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Wed, 8 Apr 2020 12:14:33 -0400 Subject: [PATCH] Some doxygen fixes --- doc/doxygen/headers/manifold.h | 2 +- include/deal.II/base/tensor.h | 34 ++++++++++--------- include/deal.II/base/thread_local_storage.h | 36 ++++++++++++--------- include/deal.II/fe/block_mask.h | 3 +- include/deal.II/fe/component_mask.h | 4 +-- include/deal.II/grid/manifold.h | 2 +- include/deal.II/grid/tria_description.h | 2 +- include/deal.II/integrators/l2.h | 2 +- source/lac/trilinos_sparse_matrix.cc | 35 ++++++++++---------- 9 files changed, 64 insertions(+), 56 deletions(-) diff --git a/doc/doxygen/headers/manifold.h b/doc/doxygen/headers/manifold.h index 5bcebc391e..0f16357df3 100644 --- a/doc/doxygen/headers/manifold.h +++ b/doc/doxygen/headers/manifold.h @@ -76,7 +76,7 @@ * * Many other examples, as well as much theoretical underpinning for the * implementation in deal.II, is provided in the - * @ref GlossGeometryPaper "geometry paper". + * @ref geometry_paper "geometry paper". * * In deal.II, a Manifold is seen as a collection of points, together * with a notion of distance between points (on the manifold). New diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index d938de5a68..c029f419cb 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -752,6 +752,7 @@ private: }; +#ifndef DOXYGEN namespace internal { template @@ -864,10 +865,10 @@ DEAL_II_CONSTEXPR inline DEAL_II_ALWAYS_INLINE DEAL_II_CUDA_HOST_DEV Tensor<0, dim, Number>::operator Number &() { // We cannot use Assert inside a CUDA kernel -#ifndef __CUDA_ARCH__ +# ifndef __CUDA_ARCH__ Assert(dim != 0, ExcMessage("Cannot access an object of type Tensor<0,0,Number>")); -#endif +# endif return value; } @@ -877,10 +878,10 @@ DEAL_II_CONSTEXPR inline DEAL_II_ALWAYS_INLINE DEAL_II_CUDA_HOST_DEV Tensor<0, dim, Number>::operator const Number &() const { // We cannot use Assert inside a CUDA kernel -#ifndef __CUDA_ARCH__ +# ifndef __CUDA_ARCH__ Assert(dim != 0, ExcMessage("Cannot access an object of type Tensor<0,0,Number>")); -#endif +# endif return value; } @@ -896,7 +897,7 @@ DEAL_II_CONSTEXPR inline DEAL_II_ALWAYS_INLINE } -#ifdef __INTEL_COMPILER +# ifdef __INTEL_COMPILER template DEAL_II_CONSTEXPR inline DEAL_II_ALWAYS_INLINE DEAL_II_CUDA_HOST_DEV Tensor<0, dim, Number> & @@ -905,7 +906,7 @@ DEAL_II_CONSTEXPR inline DEAL_II_ALWAYS_INLINE value = p.value; return *this; } -#endif +# endif template @@ -924,13 +925,13 @@ template DEAL_II_CONSTEXPR inline bool Tensor<0, dim, Number>::operator==(const Tensor<0, dim, OtherNumber> &p) const { -#if defined(DEAL_II_ADOLC_WITH_ADVANCED_BRANCHING) +# if defined(DEAL_II_ADOLC_WITH_ADVANCED_BRANCHING) Assert(!(std::is_same::value || std::is_same::value), ExcMessage( "The Tensor equality operator for ADOL-C taped numbers has not yet " "been extended to support advanced branching.")); -#endif +# endif return numbers::values_are_equal(value, p.value); } @@ -979,7 +980,7 @@ namespace internal val *= s; } -#ifdef __CUDA_ARCH__ +# ifdef __CUDA_ARCH__ template DEAL_II_CONSTEXPR inline DEAL_II_ALWAYS_INLINE DEAL_II_CUDA_HOST_DEV void multiply_assign_scalar(std::complex &, const OtherNumber &) @@ -987,7 +988,7 @@ namespace internal printf("This function is not implemented for std::complex!\n"); assert(false); } -#endif +# endif } // namespace ComplexWorkaround } // namespace internal @@ -1038,10 +1039,10 @@ DEAL_II_CONSTEXPR DEAL_II_CUDA_HOST_DEV inline DEAL_II_ALWAYS_INLINE Tensor<0, dim, Number>::norm_square() const { // We cannot use Assert inside a CUDA kernel -#ifndef __CUDA_ARCH__ +# ifndef __CUDA_ARCH__ Assert(dim != 0, ExcMessage("Cannot access an object of type Tensor<0,0,Number>")); -#endif +# endif return numbers::NumberTraits::abs_square(value); } @@ -1143,9 +1144,9 @@ namespace internal std::integral_constant) { // We cannot use Assert in a CUDA kernel -#ifndef __CUDA_ARCH__ +# ifndef __CUDA_ARCH__ AssertIndexRange(i, dim); -#endif +# endif return values[i]; } @@ -1171,12 +1172,12 @@ namespace internal std::integral_constant) { // We cannot use Assert in a CUDA kernel -#ifndef __CUDA_ARCH__ +# ifndef __CUDA_ARCH__ Assert( false, ExcMessage( "Cannot access elements of an object of type Tensor.")); -#endif +# endif return Uninitialized::value; } } // namespace TensorSubscriptor @@ -1585,6 +1586,7 @@ Tensor::serialize(Archive &ar, const unsigned int) template constexpr unsigned int Tensor::n_independent_components; +#endif // DOXYGEN /* ----------------- Non-member functions operating on tensors. ------------ */ diff --git a/include/deal.II/base/thread_local_storage.h b/include/deal.II/base/thread_local_storage.h index 8b6cd55d73..5b693fabc1 100644 --- a/include/deal.II/base/thread_local_storage.h +++ b/include/deal.II/base/thread_local_storage.h @@ -182,7 +182,14 @@ namespace Threads T data; # endif }; +} // namespace Threads +/** + * @} + */ +# ifndef DOXYGEN +namespace Threads +{ // ----------------- inline and template functions -------------------------- template @@ -202,11 +209,11 @@ namespace Threads inline T & ThreadLocalStorage::get() { -# ifdef DEAL_II_WITH_THREADS +# ifdef DEAL_II_WITH_THREADS return data.local(); -# else +# else return data; -# endif +# endif } @@ -214,12 +221,12 @@ namespace Threads inline T & ThreadLocalStorage::get(bool &exists) { -# ifdef DEAL_II_WITH_THREADS +# ifdef DEAL_II_WITH_THREADS return data.local(exists); -# else +# else exists = true; return data; -# endif +# endif } @@ -241,11 +248,11 @@ namespace Threads template inline -# ifdef DEAL_II_WITH_THREADS +# ifdef DEAL_II_WITH_THREADS tbb::enumerable_thread_specific & -# else +# else T & -# endif +# endif ThreadLocalStorage::get_implementation() { return data; @@ -257,18 +264,15 @@ namespace Threads inline void ThreadLocalStorage::clear() { -# ifdef DEAL_II_WITH_THREADS +# ifdef DEAL_II_WITH_THREADS data.clear(); -# else +# else data = T{}; -# endif +# endif } } // namespace Threads -/** - * @} - */ - +# endif // DOXYGEN //--------------------------------------------------------------------------- DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/block_mask.h b/include/deal.II/fe/block_mask.h index efc6a412c0..c2a56d252c 100644 --- a/include/deal.II/fe/block_mask.h +++ b/include/deal.II/fe/block_mask.h @@ -235,6 +235,7 @@ std::ostream & operator<<(std::ostream &out, const BlockMask &mask); +#ifndef DOXYGEN // -------------------- inline functions --------------------- inline BlockMask::BlockMask(const std::vector &block_mask) @@ -382,7 +383,7 @@ BlockMask::operator!=(const BlockMask &mask) const { return block_mask != mask.block_mask; } - +#endif // DOXYGEN DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/component_mask.h b/include/deal.II/fe/component_mask.h index d3816b7372..d9765cdb87 100644 --- a/include/deal.II/fe/component_mask.h +++ b/include/deal.II/fe/component_mask.h @@ -256,7 +256,7 @@ private: std::ostream & operator<<(std::ostream &out, const ComponentMask &mask); - +#ifndef DOXYGEN // -------------------- inline functions --------------------- inline ComponentMask::ComponentMask(const std::vector &component_mask) @@ -413,7 +413,7 @@ ComponentMask::operator!=(const ComponentMask &mask) const { return component_mask != mask.component_mask; } - +#endif // DOXYGEN DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index 34a1fd3dd8..0e29da536c 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -176,7 +176,7 @@ namespace Manifolds * geometry, but their common uses can be easily described simply through * examples. An exhaustive discussion of how, where, and why this class * is used is provided in the - * @ref GlossGeometryPaper "geometry paper". + * @ref geometry_paper "geometry paper". * * *

Common use case: Creating a new vertex

diff --git a/include/deal.II/grid/tria_description.h b/include/deal.II/grid/tria_description.h index d2a4e58699..c11af0711a 100644 --- a/include/deal.II/grid/tria_description.h +++ b/include/deal.II/grid/tria_description.h @@ -453,7 +453,7 @@ namespace TriangulationDescription * Construct a TriangulationDescription::Description. In contrast * to the function above, this function is also responsible for creating * a serial triangulation and for its partitioning (by calling the - * provided `std::functions' objects). Internally only selected processes ( + * provided `std::function` objects). Internally only selected processes ( * every n-th/each root of a group of size group_size) create a serial * triangulation and the TriangulationDescription::Description for all * processes in its group, which is communicated. diff --git a/include/deal.II/integrators/l2.h b/include/deal.II/integrators/l2.h index 56b3e85620..bbceac2086 100644 --- a/include/deal.II/integrators/l2.h +++ b/include/deal.II/integrators/l2.h @@ -234,7 +234,7 @@ namespace LocalIntegrators * * @param M11 The internal matrix for the first cell obtained as result. * @param M12 The external matrix for the first cell obtained as result. - * @param M12 The external matrix for the second cell obtained as result. + * @param M21 The external matrix for the second cell obtained as result. * @param M22 The internal matrix for the second cell obtained as result. * @param fe1 The FEValues object describing the local trial function * space for the first cell. #update_values and #update_JxW_values must be diff --git a/source/lac/trilinos_sparse_matrix.cc b/source/lac/trilinos_sparse_matrix.cc index da9ada4a61..bd04d29cc6 100644 --- a/source/lac/trilinos_sparse_matrix.cc +++ b/source/lac/trilinos_sparse_matrix.cc @@ -3461,7 +3461,7 @@ namespace TrilinosWrappers // explicit instantiations # include "trilinos_sparse_matrix.inst" - +# ifndef DOXYGEN // TODO: put these instantiations into generic file namespace TrilinosWrappers { @@ -3515,8 +3515,8 @@ namespace TrilinosWrappers dealii::LinearAlgebra::distributed::Vector &, const dealii::LinearAlgebra::distributed::Vector &) const; -# ifdef DEAL_II_WITH_MPI -# ifdef DEAL_II_TRILINOS_WITH_TPETRA +# ifdef DEAL_II_WITH_MPI +# ifdef DEAL_II_TRILINOS_WITH_TPETRA template void SparseMatrix::vmult( dealii::LinearAlgebra::TpetraWrappers::Vector &, @@ -3526,13 +3526,13 @@ namespace TrilinosWrappers SparseMatrix::vmult( dealii::LinearAlgebra::TpetraWrappers::Vector &, const dealii::LinearAlgebra::TpetraWrappers::Vector &) const; -# endif +# endif template void SparseMatrix::vmult( dealii::LinearAlgebra::EpetraWrappers::Vector &, const dealii::LinearAlgebra::EpetraWrappers::Vector &) const; -# endif +# endif template void SparseMatrix::Tvmult(MPI::Vector &, const MPI::Vector &) const; @@ -3546,8 +3546,8 @@ namespace TrilinosWrappers dealii::LinearAlgebra::distributed::Vector &, const dealii::LinearAlgebra::distributed::Vector &) const; -# ifdef DEAL_II_WITH_MPI -# ifdef DEAL_II_TRILINOS_WITH_TPETRA +# ifdef DEAL_II_WITH_MPI +# ifdef DEAL_II_TRILINOS_WITH_TPETRA template void SparseMatrix::Tvmult( dealii::LinearAlgebra::TpetraWrappers::Vector &, @@ -3557,13 +3557,13 @@ namespace TrilinosWrappers SparseMatrix::Tvmult( dealii::LinearAlgebra::TpetraWrappers::Vector &, const dealii::LinearAlgebra::TpetraWrappers::Vector &) const; -# endif +# endif template void SparseMatrix::Tvmult( dealii::LinearAlgebra::EpetraWrappers::Vector &, const dealii::LinearAlgebra::EpetraWrappers::Vector &) const; -# endif +# endif template void SparseMatrix::vmult_add(MPI::Vector &, const MPI::Vector &) const; @@ -3577,8 +3577,8 @@ namespace TrilinosWrappers dealii::LinearAlgebra::distributed::Vector &, const dealii::LinearAlgebra::distributed::Vector &) const; -# ifdef DEAL_II_WITH_MPI -# ifdef DEAL_II_TRILINOS_WITH_TPETRA +# ifdef DEAL_II_WITH_MPI +# ifdef DEAL_II_TRILINOS_WITH_TPETRA template void SparseMatrix::vmult_add( dealii::LinearAlgebra::TpetraWrappers::Vector &, @@ -3588,13 +3588,13 @@ namespace TrilinosWrappers SparseMatrix::vmult_add( dealii::LinearAlgebra::TpetraWrappers::Vector &, const dealii::LinearAlgebra::TpetraWrappers::Vector &) const; -# endif +# endif template void SparseMatrix::vmult_add( dealii::LinearAlgebra::EpetraWrappers::Vector &, const dealii::LinearAlgebra::EpetraWrappers::Vector &) const; -# endif +# endif template void SparseMatrix::Tvmult_add(MPI::Vector &, const MPI::Vector &) const; @@ -3608,8 +3608,8 @@ namespace TrilinosWrappers dealii::LinearAlgebra::distributed::Vector &, const dealii::LinearAlgebra::distributed::Vector &) const; -# ifdef DEAL_II_WITH_MPI -# ifdef DEAL_II_TRILINOS_WITH_TPETRA +# ifdef DEAL_II_WITH_MPI +# ifdef DEAL_II_TRILINOS_WITH_TPETRA template void SparseMatrix::Tvmult_add( dealii::LinearAlgebra::TpetraWrappers::Vector &, @@ -3619,14 +3619,15 @@ namespace TrilinosWrappers SparseMatrix::Tvmult_add( dealii::LinearAlgebra::TpetraWrappers::Vector &, const dealii::LinearAlgebra::TpetraWrappers::Vector &) const; -# endif +# endif template void SparseMatrix::Tvmult_add( dealii::LinearAlgebra::EpetraWrappers::Vector &, const dealii::LinearAlgebra::EpetraWrappers::Vector &) const; -# endif +# endif } // namespace TrilinosWrappers +# endif // DOXYGEN DEAL_II_NAMESPACE_CLOSE -- 2.39.5