]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix doxygen warnings 17237/head
authorDaniel Arndt <arndtd@ornl.gov>
Tue, 9 Jul 2024 17:45:48 +0000 (13:45 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Tue, 9 Jul 2024 21:07:16 +0000 (17:07 -0400)
24 files changed:
doc/doxygen/headers/laoperators.h
include/deal.II/base/geometry_info.h
include/deal.II/base/mpi_consensus_algorithms.h
include/deal.II/base/thread_management.h
include/deal.II/distributed/fully_distributed_tria.h
include/deal.II/distributed/tria_base.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/reference_cell.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_description.h
include/deal.II/lac/ginkgo_solver.h
include/deal.II/lac/petsc_block_sparse_matrix.h
include/deal.II/lac/petsc_block_vector.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_tpetra_block_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_block_vector.h
include/deal.II/matrix_free/portable_fe_evaluation.h
include/deal.II/matrix_free/portable_matrix_free.h
include/deal.II/matrix_free/portable_tensor_product_kernels.h
include/deal.II/particles/data_out.h
include/deal.II/particles/particle.h
include/deal.II/particles/particle_handler.h

index 096773187ba474c23ca2196f429f488a4bf4a8ef..8460cdf4c2fb956827e6f0c5e99acfdaddf17149 100644 (file)
  *
  *
  * @ingroup LAC
- * @ingroup MATRICES
  */
index 3371c9b734d0464e513ecc672d5c57ea74ba67b6..5359b7efa57c5d04cc75d958ebf0090eae374f58 100644 (file)
@@ -479,8 +479,6 @@ private:
  * <code>RefinementPossibilities@<1@></code>,
  * <code>RefinementPossibilities@<2@></code>, and
  * <code>RefinementPossibilities@<3@></code>.
- *
- * @ingroup aniso
  */
 template <int dim>
 struct RefinementPossibilities
@@ -549,8 +547,6 @@ struct RefinementPossibilities
  *
  * This specialization is used for <code>dim=1</code>, where it offers
  * refinement in x-direction.
- *
- * @ingroup aniso
  */
 template <>
 struct RefinementPossibilities<1>
@@ -615,8 +611,6 @@ struct RefinementPossibilities<1>
  * This specialization is used for <code>dim=2</code>, where it offers
  * refinement in x- and y-direction separately, as well as isotropic
  * refinement in both directions at the same time.
- *
- * @ingroup aniso
  */
 template <>
 struct RefinementPossibilities<2>
@@ -690,8 +684,6 @@ struct RefinementPossibilities<2>
  * This specialization is used for <code>dim=3</code>, where it offers
  * refinement in x-, y- and z-direction separately, as well as combinations of
  * these and isotropic refinement in all directions at the same time.
- *
- * @ingroup aniso
  */
 template <>
 struct RefinementPossibilities<3>
@@ -781,8 +773,6 @@ struct RefinementPossibilities<3>
  * <code>dim=2</code>, etc.). Possible values of this class are the ones
  * listed in the enumeration declared within the base class; see there for
  * more information.
- *
- * @ingroup aniso
  */
 template <int dim>
 class RefinementCase : public RefinementPossibilities<dim>
@@ -922,8 +912,6 @@ namespace internal
    * <code>SubfacePossibilities@<1@></code>,
    * <code>SubfacePossibilities@<2@></code> and
    * <code>SubfacePossibilities@<3@></code>.
-   *
-   * @ingroup aniso
    */
   template <int dim>
   struct SubfacePossibilities
@@ -951,8 +939,6 @@ namespace internal
    * space dimension @p dim) might be subdivided into subfaces.
    *
    * For <code>dim=0</code> we provide a dummy implementation only.
-   *
-   * @ingroup aniso
    */
   template <>
   struct SubfacePossibilities<0>
@@ -984,8 +970,6 @@ namespace internal
    *
    * For <code>dim=1</code> there are no faces. Thereby, there are no subface
    * possibilities.
-   *
-   * @ingroup aniso
    */
   template <>
   struct SubfacePossibilities<1>
@@ -1018,8 +1002,6 @@ namespace internal
    * This specialization is used for <code>dim=2</code>, where it offers the
    * following possibilities: a face (line) being refined
    * (<code>case_x</code>) or not refined (<code>case_no</code>).
-   *
-   * @ingroup aniso
    */
   template <>
   struct SubfacePossibilities<2>
@@ -1137,8 +1119,6 @@ namespace internal
    * *---*---*
    *
    * @endcode
-   *
-   * @ingroup aniso
    */
   template <>
   struct SubfacePossibilities<3>
@@ -1171,8 +1151,6 @@ namespace internal
   /**
    * A class that provides all possible cases a face (in the current space
    * dimension @p dim) might be subdivided into subfaces.
-   *
-   * @ingroup aniso
    */
   template <int dim>
   class SubfaceCase : public SubfacePossibilities<dim>
@@ -1248,7 +1226,7 @@ struct GeometryInfo;
  * This information should always replace hard-coded numbers of vertices,
  * neighbors and so on, since it can be used dimension independently.
  *
- * @ingroup grid geomprimitives aniso
+ * @ingroup grid geomprimitives
  */
 template <>
 struct GeometryInfo<0>
@@ -1979,7 +1957,7 @@ struct GeometryInfo<0>
  * @ref Instantiations
  * in the manual).
  *
- * @ingroup grid geomprimitives aniso
+ * @ingroup grid geomprimitives
  */
 template <int dim>
 struct GeometryInfo
index 4a9b5e71fc2ed6e2a8208e1b99345369d7ac3f92..14c3503c785e4bc2ad40f6eaf28481e84e852c7e 100644 (file)
@@ -125,8 +125,6 @@ namespace Utilities
      * an MPI communicator, a list of targets, and function objects that
      * encode and decode the messages to be sent, but no functions for
      * encoding a reply, or processing a reply.
-     *
-     * @ingroup MPI
      */
     namespace ConsensusAlgorithms
     {
index f130ef0c95e700f9d3b1de8e9de069b1e4ca31bb..9a0ff2f7a8101e53bb2fd03c1c536e42fef8cb75 100644 (file)
@@ -1367,8 +1367,6 @@ namespace Threads
    * the calls that add subtasks. Otherwise, there might be a deadlock. In
    * other words, a Task object should never passed on to another task for
    * calling the join() method.
-   *
-   * @ingroup tasks
    */
   template <typename RT = void>
   class TaskGroup
index 343b919cb62d5704ce440d0d7f5205a71066260c..a54abc6d04b0225c01c2e069b3c03c5aadbc6f61 100644 (file)
@@ -41,8 +41,6 @@ namespace parallel
 {
   /**
    * A namespace for the fully distributed triangulation.
-   *
-   * @ingroup parallel
    */
   namespace fullydistributed
   {
index 0156954533fa3b1932372bc394f2a1fa678276ed..9291380e5b13e0d2283b8c18ad0922b6187c90cc 100644 (file)
@@ -216,8 +216,6 @@ namespace parallel
      * will represent the number of different indicators (which is greater or
      * equal one).
      *
-     * @ingroup boundary
-     *
      * @see
      * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
      *
index bb58a41af4efa117e680246e095cfeaa945e79d0..e083008c66351b26f11a4b1c9123de75a11602e1 100644 (file)
@@ -2427,8 +2427,6 @@ namespace GridGenerator
   /**
    * Namespace Airfoil contains classes and functions in order to create a
    * C-type mesh for the (flow) field around Joukowski or NACA airfoils.
-   *
-   * @ingroup GridGenerator
    */
   namespace Airfoil
   {
index daeee87a316c1f5d41f49c871756855f6bc7ea49..507fc336007e74598a71ee9bbf9954a84dfe2a6b 100644 (file)
@@ -121,7 +121,7 @@ enum class IsotropicRefinementChoice : std::uint8_t
  * @ref GlossReferenceCell "reference cell"
  * glossary entry.
  *
- * @ingroup grid geomprimitives aniso reordering
+ * @ingroup grid geomprimitives reordering
  */
 class ReferenceCell
 {
index 7973e4667f4727f70f00e1dcb71cf78b99647cb2..24a1755ddaedf5bb89d635e651da7d18329a1474 100644 (file)
@@ -1307,7 +1307,7 @@ namespace internal
  * object, you should be well aware that you might involuntarily alter the
  * data stored in the triangulation.
  *
- * @ingroup grid aniso
+ * @ingroup grid
  *
  * @dealiiConceptRequires{(concepts::is_valid_dim_spacedim<dim, spacedim>)}
  */
@@ -1959,8 +1959,6 @@ public:
    * will represent the number of different indicators (which is greater or
    * equal one).
    *
-   * @ingroup boundary
-   *
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
index ef3cf0e2ace73ad2fe5e140a7f60d8fb948f91d6..e56691aee54bfa01fda4fd560450d56fd6314dfd 100644 (file)
@@ -1160,8 +1160,6 @@ public:
    * the value you are trying to set makes sense under the current
    * circumstances.
    *
-   * @ingroup boundary
-   *
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
@@ -1193,8 +1191,6 @@ public:
    * the result of not using the correct function in the results section of
    * step-49.
    *
-   * @ingroup boundary
-   *
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
@@ -2946,8 +2942,6 @@ public:
    * the value you are trying to set makes sense under the current
    * circumstances.
    *
-   * @ingroup boundary
-   *
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
@@ -2969,8 +2963,6 @@ public:
    * vertex, there are no lower-dimensional object and this function is
    * equivalent to calling set_boundary_id() with the same argument.
    *
-   * @ingroup boundary
-   *
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
index 62c223a6fed97deb5ebc10ebe5b25c26f4058b79..6e12e65b3792fb6a3d7134db2a4a3afee5b7e1fd 100644 (file)
@@ -481,8 +481,6 @@ namespace TriangulationDescription
 
   /**
    * A namespace for TriangulationDescription::Description utility functions.
-   *
-   * @ingroup TriangulationDescription
    */
   namespace Utilities
   {
index 9a9192865db04fe790626ccd2c9bb7fadbdd5b0c..835e2a7e0a03bb518c62d0a722a69d9266911dbc 100644 (file)
@@ -42,8 +42,6 @@ namespace GinkgoWrappers
    * available at <a Ginkgo
    * href="https://ginkgo-project.github.io/ginkgo/doc/develop/"> documentation
    * and manual pages</a>.
-   *
-   * @ingroup GinkgoWrappers
    */
   template <typename ValueType, typename IndexType>
   class SolverBase
@@ -207,8 +205,6 @@ namespace GinkgoWrappers
 
   /**
    * An implementation of the solver interface using the Ginkgo CG solver.
-   *
-   * @ingroup GinkgoWrappers
    */
   template <typename ValueType = double, typename IndexType = int32_t>
   class SolverCG : public SolverBase<ValueType, IndexType>
@@ -263,8 +259,6 @@ namespace GinkgoWrappers
 
   /**
    * An implementation of the solver interface using the Ginkgo Bicgstab solver.
-   *
-   * @ingroup GinkgoWrappers
    */
   template <typename ValueType = double, typename IndexType = int32_t>
   class SolverBicgstab : public SolverBase<ValueType, IndexType>
@@ -321,8 +315,6 @@ namespace GinkgoWrappers
    *
    * CGS or the conjugate gradient square method is an iterative type Krylov
    * subspace method which is suitable for general systems.
-   *
-   * @ingroup GinkgoWrappers
    */
   template <typename ValueType = double, typename IndexType = int32_t>
   class SolverCGS : public SolverBase<ValueType, IndexType>
@@ -388,8 +380,6 @@ namespace GinkgoWrappers
    * vectors spanning the Krylov subspace. This increases the computational cost
    * of every Krylov solver iteration but allows for non-constant
    * preconditioners.
-   *
-   * @ingroup GinkgoWrappers
    */
   template <typename ValueType = double, typename IndexType = int32_t>
   class SolverFCG : public SolverBase<ValueType, IndexType>
@@ -443,8 +433,6 @@ namespace GinkgoWrappers
 
   /**
    * An implementation of the solver interface using the Ginkgo GMRES solver.
-   *
-   * @ingroup GinkgoWrappers
    */
   template <typename ValueType = double, typename IndexType = int32_t>
   class SolverGMRES : public SolverBase<ValueType, IndexType>
@@ -513,8 +501,6 @@ namespace GinkgoWrappers
    * Iterative refinement (IR) is an iterative method that uses another coarse
    * method to approximate the error of the current solution via the current
    * residual.
-   *
-   * @ingroup GinkgoWrappers
    */
   template <typename ValueType = double, typename IndexType = int32_t>
   class SolverIR : public SolverBase<ValueType, IndexType>
index d0118a61f7bd0a542416a3753ce13c738826140e..9c301b43bb5549de2f0d217639014547a2fd285b 100644 (file)
@@ -60,8 +60,8 @@ namespace PETScWrappers
      * collect_sizes() function, for much the same reason as is documented
      * with the BlockSparsityPattern class.
      *
-     * @ingroup Matrix1 @see
-     * @ref GlossBlockLA "Block (linear algebra)"
+     * @ingroup Matrix1
+     * @see @ref GlossBlockLA "Block (linear algebra)"
      */
     class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
     {
index 801997ed38e04785b25d1a7ce488c9f967666e7e..7c24b307299e4d0686122b42312dbe923860e965 100644 (file)
@@ -54,8 +54,8 @@ namespace PETScWrappers
      * specify the sizes of the individual blocks, but also the number of
      * elements of each of these blocks to be stored on the local process.
      *
-     * @ingroup Vectors @see
-     * @ref GlossBlockLA "Block (linear algebra)"
+     * @ingroup Vectors
+     * @see @ref GlossBlockLA "Block (linear algebra)"
      */
     class BlockVector : public BlockVectorBase<Vector>
     {
index ea9e413fbde8da750f2a51565370ef5397daff61..ff888c6a5e15ad9bc1623c365e416ddf09559615 100644 (file)
@@ -65,8 +65,8 @@ namespace TrilinosWrappers
    * function, for much the same reason as is documented with the
    * BlockSparsityPattern class.
    *
-   * @ingroup Matrix1 @see
-   * @ref GlossBlockLA "Block (linear algebra)"
+   * @ingroup Matrix1
+   * @see @ref GlossBlockLA "Block (linear algebra)"
    */
   class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
   {
index 5cad7345d0ef9af6e99225ef2f84ee865d54d259..5a536489d1595caba85f9849fccba1ea06c1cc40 100644 (file)
@@ -68,8 +68,8 @@ namespace TrilinosWrappers
      * elements of each of these blocks to be stored on the local process.
      *
      * @ingroup Vectors
-     * @ingroup TrilinosWrappers @see
-     * @ref GlossBlockLA "Block (linear algebra)"
+     * @ingroup TrilinosWrappers
+     * @see @ref GlossBlockLA "Block (linear algebra)"
      */
     class BlockVector : public dealii::BlockVectorBase<MPI::Vector>
     {
index a5e1f8f8440f26b2977954edcea72dce4aba2f94..c1b9683ec3f89218a5fcd8cdb2fcd1bbea86f906 100644 (file)
@@ -68,8 +68,8 @@ namespace LinearAlgebra
      * function, for much the same reason as is documented with the
      * BlockSparsityPattern class.
      *
-     * @ingroup Matrix1 @see
-     * @ref GlossBlockLA "Block (linear algebra)"
+     * @ingroup Matrix1
+     * @see @ref GlossBlockLA "Block (linear algebra)"
      */
     template <typename Number, typename MemorySpace = dealii::MemorySpace::Host>
     class BlockSparseMatrix
index 7d9f73132a63b5eef596a4326200aad3be69f45a..cc09a41de90533c23085724f754c2877b49f2969 100644 (file)
@@ -68,8 +68,8 @@ namespace LinearAlgebra
      * elements of each of these blocks to be stored on the local process.
      *
      * @ingroup Vectors
-     * @ingroup TrilinosWrappers @see
-     * @ref GlossBlockLA "Block (linear algebra)"
+     * @ingroup TrilinosWrappers
+     * @see @ref GlossBlockLA "Block (linear algebra)"
      */
     template <typename Number, typename MemorySpace = dealii::MemorySpace::Host>
     class BlockVector : public dealii::BlockVectorBase<
index 505aeedc7043ebeb27280399f3ab13d1a652079a..7a4c28af5942be610f324e74e636a73fedca7ed4 100644 (file)
@@ -60,7 +60,6 @@ namespace Portable
    * double.
    *
    * @ingroup CUDAWrappers
-   * @ingroup Portable
    */
   template <int dim,
             int fe_degree,
index 24c20ee9bd4e79be73632f9117a00303bcf6ff25..2b25b1ef3ff551f8e32f706d0017d4cdf8dd57e6 100644 (file)
@@ -88,7 +88,6 @@ namespace Portable
    * @note Only float and double are supported.
    *
    * @ingroup CUDAWrappers
-   * @ingroup Portable
    */
   template <int dim, typename Number = double>
   class MatrixFree : public Subscriptor
index f34bc2ff91827ddf2b22260fdd50f412f1d30c4c..b340b683273570256a1fb750aec0da9afe91e941 100644 (file)
@@ -34,7 +34,6 @@ namespace Portable
      * products are implemented.
      *
      * @ingroup CUDAWrappers
-     * @ingroup Portable
      */
     // TODO: for now only the general variant is implemented
     enum EvaluatorVariant
@@ -338,7 +337,6 @@ namespace Portable
      * Generic evaluator framework.
      *
      * @ingroup CUDAWrappers
-     * @ingroup Portable
      */
     template <EvaluatorVariant variant,
               int              dim,
@@ -355,7 +353,6 @@ namespace Portable
      * of the basis functions.
      *
      * @ingroup CUDAWrappers
-     * @ingroup Portable
      */
     template <int dim, int fe_degree, int n_q_points_1d, typename Number>
     struct EvaluatorTensorProduct<evaluate_general,
index f77d28bb9028dca2c1e4d2a8b53444969532635c..e2c55ad0778c2c6b4bd5e87da4aebcc36f5727ce 100644 (file)
@@ -38,8 +38,6 @@ namespace Particles
    * The class does, in essence, for particles what ::DataOut does for
    * finite element fields, using a similar interface. It is used in
    * step-19, for example.
-   *
-   * @ingroup Particle
    */
   template <int dim, int spacedim = dim>
   class DataOut : public dealii::DataOutInterface<0, spacedim>
index 8b57a6ba5cfb52c59dbb8ac5a2167234981a3668..29732b9cd859e29725b5362954a7027a6f7e31a3 100644 (file)
@@ -88,8 +88,6 @@ namespace Particles
    * 1.0, "blue" to 2.0, and "green" to 3.0. The conversion functions
    * to translate between these two representations should then not be very
    * difficult to write either.
-   *
-   * @ingroup Particle
    */
   template <int dim, int spacedim = dim>
   class Particle
index b3c4f0e533f901f759caf3556f2417fa50bc4a85..ade085a03debfa89faa42bbdb2e3505f6e672e89 100644 (file)
@@ -57,8 +57,6 @@ namespace Particles
    * For examples on how to use this class to track particles, store properties
    * on particles, and let the properties on the particles influence the
    * finite-element solution see step-19, step-68, and step-70.
-   *
-   * @ingroup Particle
    */
   template <int dim, int spacedim = dim>
   class ParticleHandler : public Subscriptor

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.