]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Some doxygen fixes 9859/head
authorDaniel Arndt <arndtd@ornl.gov>
Wed, 8 Apr 2020 16:14:33 +0000 (12:14 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Wed, 8 Apr 2020 16:14:33 +0000 (12:14 -0400)
doc/doxygen/headers/manifold.h
include/deal.II/base/tensor.h
include/deal.II/base/thread_local_storage.h
include/deal.II/fe/block_mask.h
include/deal.II/fe/component_mask.h
include/deal.II/grid/manifold.h
include/deal.II/grid/tria_description.h
include/deal.II/integrators/l2.h
source/lac/trilinos_sparse_matrix.cc

index 5bcebc391e62c21dce984859c268f57ad322917c..0f16357df34380e503f88655ef24943028ef0107 100644 (file)
@@ -76,7 +76,7 @@
  * </ul>
  * 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
index d938de5a688aa931ac73957a7a99416daa0c630e..c029f419cb6db4da66ad2316dbb0cf3ed96e751b 100644 (file)
@@ -752,6 +752,7 @@ private:
 };
 
 
+#ifndef DOXYGEN
 namespace internal
 {
   template <int rank, int dim, typename T, typename U>
@@ -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 <int dim, typename Number>
 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 <int dim, typename Number>
@@ -924,13 +925,13 @@ template <typename OtherNumber>
 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<Number, adouble>::value ||
            std::is_same<OtherNumber, adouble>::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 <typename Number, typename OtherNumber>
     DEAL_II_CONSTEXPR inline DEAL_II_ALWAYS_INLINE DEAL_II_CUDA_HOST_DEV void
                                                    multiply_assign_scalar(std::complex<Number> &, const OtherNumber &)
@@ -987,7 +988,7 @@ namespace internal
       printf("This function is not implemented for std::complex<Number>!\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<Number>::abs_square(value);
 }
 
@@ -1143,9 +1144,9 @@ namespace internal
                                       std::integral_constant<int, dim>)
     {
       // 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<int, 0>)
     {
       // 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<rank,0,Number>."));
-#endif
+#  endif
       return Uninitialized<ArrayElementType>::value;
     }
   } // namespace TensorSubscriptor
@@ -1585,6 +1586,7 @@ Tensor<rank_, dim, Number>::serialize(Archive &ar, const unsigned int)
 template <int rank_, int dim, typename Number>
 constexpr unsigned int Tensor<rank_, dim, Number>::n_independent_components;
 
+#endif // DOXYGEN
 
 /* ----------------- Non-member functions operating on tensors. ------------ */
 
index 8b6cd55d7345138d09ad5b08fbf346f5c8e8f1e0..5b693fabc1f71eb01fd99696b80741f9c6d90069 100644 (file)
@@ -182,7 +182,14 @@ namespace Threads
     T data;
 #  endif
   };
+} // namespace Threads
+/**
+ * @}
+ */
 
+#  ifndef DOXYGEN
+namespace Threads
+{
   // ----------------- inline and template functions --------------------------
 
   template <typename T>
@@ -202,11 +209,11 @@ namespace Threads
   inline T &
   ThreadLocalStorage<T>::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<T>::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 <typename T>
   inline
-#  ifdef DEAL_II_WITH_THREADS
+#    ifdef DEAL_II_WITH_THREADS
     tbb::enumerable_thread_specific<T> &
-#  else
+#    else
     T &
-#  endif
+#    endif
     ThreadLocalStorage<T>::get_implementation()
   {
     return data;
@@ -257,18 +264,15 @@ namespace Threads
   inline void
   ThreadLocalStorage<T>::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
index efc6a412c0f607655734d4a4629bd764e37427b5..c2a56d252c14981e7bd502c9df6da78e9fc32792 100644 (file)
@@ -235,6 +235,7 @@ std::ostream &
 operator<<(std::ostream &out, const BlockMask &mask);
 
 
+#ifndef DOXYGEN
 // -------------------- inline functions ---------------------
 
 inline BlockMask::BlockMask(const std::vector<bool> &block_mask)
@@ -382,7 +383,7 @@ BlockMask::operator!=(const BlockMask &mask) const
 {
   return block_mask != mask.block_mask;
 }
-
+#endif // DOXYGEN
 
 DEAL_II_NAMESPACE_CLOSE
 
index d3816b7372f743d5e9bbe814191348299d8ffa3c..d9765cdb87438a811762dd74f12fa704b83a8391 100644 (file)
@@ -256,7 +256,7 @@ private:
 std::ostream &
 operator<<(std::ostream &out, const ComponentMask &mask);
 
-
+#ifndef DOXYGEN
 // -------------------- inline functions ---------------------
 
 inline ComponentMask::ComponentMask(const std::vector<bool> &component_mask)
@@ -413,7 +413,7 @@ ComponentMask::operator!=(const ComponentMask &mask) const
 {
   return component_mask != mask.component_mask;
 }
-
+#endif // DOXYGEN
 
 
 DEAL_II_NAMESPACE_CLOSE
index 34a1fd3dd8fc166751a2d22d99a9c15dda3784b7..0e29da536c1e9234f18f7a226088b24555496d81 100644 (file)
@@ -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".
  *
  *
  * <h3>Common use case: Creating a new vertex</h3>
index d2a4e5869989eb431e55cf09dcb9665b8942096c..c11af0711af7919b9d7cbb4879246340bbab9ed7 100644 (file)
@@ -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.
index 56b3e85620b3065d3c4e7fb0e313aa38f468917b..bbceac2086eb90c862bebe7dba0238f33509a595 100644 (file)
@@ -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
index da9ada4a616959457cc71d38267e39be42c10601..bd04d29cc61bf115c4ab3787bc51ffc8c2157059 100644 (file)
@@ -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<double> &,
     const dealii::LinearAlgebra::distributed::Vector<double> &) 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<double> &,
@@ -3526,13 +3526,13 @@ namespace TrilinosWrappers
   SparseMatrix::vmult(
     dealii::LinearAlgebra::TpetraWrappers::Vector<float> &,
     const dealii::LinearAlgebra::TpetraWrappers::Vector<float> &) 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<double> &,
     const dealii::LinearAlgebra::distributed::Vector<double> &) 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<double> &,
@@ -3557,13 +3557,13 @@ namespace TrilinosWrappers
   SparseMatrix::Tvmult(
     dealii::LinearAlgebra::TpetraWrappers::Vector<float> &,
     const dealii::LinearAlgebra::TpetraWrappers::Vector<float> &) 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<double> &,
     const dealii::LinearAlgebra::distributed::Vector<double> &) 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<double> &,
@@ -3588,13 +3588,13 @@ namespace TrilinosWrappers
   SparseMatrix::vmult_add(
     dealii::LinearAlgebra::TpetraWrappers::Vector<float> &,
     const dealii::LinearAlgebra::TpetraWrappers::Vector<float> &) 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<double> &,
     const dealii::LinearAlgebra::distributed::Vector<double> &) 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<double> &,
@@ -3619,14 +3619,15 @@ namespace TrilinosWrappers
   SparseMatrix::Tvmult_add(
     dealii::LinearAlgebra::TpetraWrappers::Vector<float> &,
     const dealii::LinearAlgebra::TpetraWrappers::Vector<float> &) 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
 

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.