From be4f1773bb1cdaf582e14ca5c8ef6f072928fdd2 Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Tue, 9 Jul 2024 13:45:48 -0400 Subject: [PATCH] Fix doxygen warnings --- doc/doxygen/headers/laoperators.h | 1 - include/deal.II/base/geometry_info.h | 26 ++----------------- .../deal.II/base/mpi_consensus_algorithms.h | 2 -- include/deal.II/base/thread_management.h | 2 -- .../distributed/fully_distributed_tria.h | 2 -- include/deal.II/distributed/tria_base.h | 2 -- include/deal.II/grid/grid_generator.h | 2 -- include/deal.II/grid/reference_cell.h | 2 +- include/deal.II/grid/tria.h | 4 +-- include/deal.II/grid/tria_accessor.h | 8 ------ include/deal.II/grid/tria_description.h | 2 -- include/deal.II/lac/ginkgo_solver.h | 14 ---------- .../deal.II/lac/petsc_block_sparse_matrix.h | 4 +-- include/deal.II/lac/petsc_block_vector.h | 4 +-- .../lac/trilinos_block_sparse_matrix.h | 4 +-- .../lac/trilinos_parallel_block_vector.h | 4 +-- .../lac/trilinos_tpetra_block_sparse_matrix.h | 4 +-- .../lac/trilinos_tpetra_block_vector.h | 4 +-- .../matrix_free/portable_fe_evaluation.h | 1 - .../matrix_free/portable_matrix_free.h | 1 - .../portable_tensor_product_kernels.h | 3 --- include/deal.II/particles/data_out.h | 2 -- include/deal.II/particles/particle.h | 2 -- include/deal.II/particles/particle_handler.h | 2 -- 24 files changed, 16 insertions(+), 86 deletions(-) diff --git a/doc/doxygen/headers/laoperators.h b/doc/doxygen/headers/laoperators.h index 096773187b..8460cdf4c2 100644 --- a/doc/doxygen/headers/laoperators.h +++ b/doc/doxygen/headers/laoperators.h @@ -193,5 +193,4 @@ * * * @ingroup LAC - * @ingroup MATRICES */ diff --git a/include/deal.II/base/geometry_info.h b/include/deal.II/base/geometry_info.h index 3371c9b734..5359b7efa5 100644 --- a/include/deal.II/base/geometry_info.h +++ b/include/deal.II/base/geometry_info.h @@ -479,8 +479,6 @@ private: * RefinementPossibilities@<1@>, * RefinementPossibilities@<2@>, and * RefinementPossibilities@<3@>. - * - * @ingroup aniso */ template struct RefinementPossibilities @@ -549,8 +547,6 @@ struct RefinementPossibilities * * This specialization is used for dim=1, 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 dim=2, 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 dim=3, 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> * dim=2, 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 class RefinementCase : public RefinementPossibilities @@ -922,8 +912,6 @@ namespace internal * SubfacePossibilities@<1@>, * SubfacePossibilities@<2@> and * SubfacePossibilities@<3@>. - * - * @ingroup aniso */ template struct SubfacePossibilities @@ -951,8 +939,6 @@ namespace internal * space dimension @p dim) might be subdivided into subfaces. * * For dim=0 we provide a dummy implementation only. - * - * @ingroup aniso */ template <> struct SubfacePossibilities<0> @@ -984,8 +970,6 @@ namespace internal * * For dim=1 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 dim=2, where it offers the * following possibilities: a face (line) being refined * (case_x) or not refined (case_no). - * - * @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 class SubfaceCase : public SubfacePossibilities @@ -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 struct GeometryInfo diff --git a/include/deal.II/base/mpi_consensus_algorithms.h b/include/deal.II/base/mpi_consensus_algorithms.h index 4a9b5e71fc..14c3503c78 100644 --- a/include/deal.II/base/mpi_consensus_algorithms.h +++ b/include/deal.II/base/mpi_consensus_algorithms.h @@ -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 { diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index f130ef0c95..9a0ff2f7a8 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -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 class TaskGroup diff --git a/include/deal.II/distributed/fully_distributed_tria.h b/include/deal.II/distributed/fully_distributed_tria.h index 343b919cb6..a54abc6d04 100644 --- a/include/deal.II/distributed/fully_distributed_tria.h +++ b/include/deal.II/distributed/fully_distributed_tria.h @@ -41,8 +41,6 @@ namespace parallel { /** * A namespace for the fully distributed triangulation. - * - * @ingroup parallel */ namespace fullydistributed { diff --git a/include/deal.II/distributed/tria_base.h b/include/deal.II/distributed/tria_base.h index 0156954533..9291380e5b 100644 --- a/include/deal.II/distributed/tria_base.h +++ b/include/deal.II/distributed/tria_base.h @@ -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" * diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index bb58a41af4..e083008c66 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -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 { diff --git a/include/deal.II/grid/reference_cell.h b/include/deal.II/grid/reference_cell.h index daeee87a31..507fc33600 100644 --- a/include/deal.II/grid/reference_cell.h +++ b/include/deal.II/grid/reference_cell.h @@ -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 { diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 7973e4667f..24a1755dda 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -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)} */ @@ -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" */ diff --git a/include/deal.II/grid/tria_accessor.h b/include/deal.II/grid/tria_accessor.h index ef3cf0e2ac..e56691aee5 100644 --- a/include/deal.II/grid/tria_accessor.h +++ b/include/deal.II/grid/tria_accessor.h @@ -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" */ diff --git a/include/deal.II/grid/tria_description.h b/include/deal.II/grid/tria_description.h index 62c223a6fe..6e12e65b37 100644 --- a/include/deal.II/grid/tria_description.h +++ b/include/deal.II/grid/tria_description.h @@ -481,8 +481,6 @@ namespace TriangulationDescription /** * A namespace for TriangulationDescription::Description utility functions. - * - * @ingroup TriangulationDescription */ namespace Utilities { diff --git a/include/deal.II/lac/ginkgo_solver.h b/include/deal.II/lac/ginkgo_solver.h index 9a9192865d..835e2a7e0a 100644 --- a/include/deal.II/lac/ginkgo_solver.h +++ b/include/deal.II/lac/ginkgo_solver.h @@ -42,8 +42,6 @@ namespace GinkgoWrappers * available at documentation * and manual pages. - * - * @ingroup GinkgoWrappers */ template class SolverBase @@ -207,8 +205,6 @@ namespace GinkgoWrappers /** * An implementation of the solver interface using the Ginkgo CG solver. - * - * @ingroup GinkgoWrappers */ template class SolverCG : public SolverBase @@ -263,8 +259,6 @@ namespace GinkgoWrappers /** * An implementation of the solver interface using the Ginkgo Bicgstab solver. - * - * @ingroup GinkgoWrappers */ template class SolverBicgstab : public SolverBase @@ -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 class SolverCGS : public SolverBase @@ -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 class SolverFCG : public SolverBase @@ -443,8 +433,6 @@ namespace GinkgoWrappers /** * An implementation of the solver interface using the Ginkgo GMRES solver. - * - * @ingroup GinkgoWrappers */ template class SolverGMRES : public SolverBase @@ -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 class SolverIR : public SolverBase diff --git a/include/deal.II/lac/petsc_block_sparse_matrix.h b/include/deal.II/lac/petsc_block_sparse_matrix.h index d0118a61f7..9c301b43bb 100644 --- a/include/deal.II/lac/petsc_block_sparse_matrix.h +++ b/include/deal.II/lac/petsc_block_sparse_matrix.h @@ -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 { diff --git a/include/deal.II/lac/petsc_block_vector.h b/include/deal.II/lac/petsc_block_vector.h index 801997ed38..7c24b30729 100644 --- a/include/deal.II/lac/petsc_block_vector.h +++ b/include/deal.II/lac/petsc_block_vector.h @@ -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 { diff --git a/include/deal.II/lac/trilinos_block_sparse_matrix.h b/include/deal.II/lac/trilinos_block_sparse_matrix.h index ea9e413fbd..ff888c6a5e 100644 --- a/include/deal.II/lac/trilinos_block_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_block_sparse_matrix.h @@ -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 { diff --git a/include/deal.II/lac/trilinos_parallel_block_vector.h b/include/deal.II/lac/trilinos_parallel_block_vector.h index 5cad7345d0..5a536489d1 100644 --- a/include/deal.II/lac/trilinos_parallel_block_vector.h +++ b/include/deal.II/lac/trilinos_parallel_block_vector.h @@ -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 { diff --git a/include/deal.II/lac/trilinos_tpetra_block_sparse_matrix.h b/include/deal.II/lac/trilinos_tpetra_block_sparse_matrix.h index a5e1f8f844..c1b9683ec3 100644 --- a/include/deal.II/lac/trilinos_tpetra_block_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_tpetra_block_sparse_matrix.h @@ -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 class BlockSparseMatrix diff --git a/include/deal.II/lac/trilinos_tpetra_block_vector.h b/include/deal.II/lac/trilinos_tpetra_block_vector.h index 7d9f73132a..cc09a41de9 100644 --- a/include/deal.II/lac/trilinos_tpetra_block_vector.h +++ b/include/deal.II/lac/trilinos_tpetra_block_vector.h @@ -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 class BlockVector : public dealii::BlockVectorBase< diff --git a/include/deal.II/matrix_free/portable_fe_evaluation.h b/include/deal.II/matrix_free/portable_fe_evaluation.h index 505aeedc70..7a4c28af59 100644 --- a/include/deal.II/matrix_free/portable_fe_evaluation.h +++ b/include/deal.II/matrix_free/portable_fe_evaluation.h @@ -60,7 +60,6 @@ namespace Portable * double. * * @ingroup CUDAWrappers - * @ingroup Portable */ template class MatrixFree : public Subscriptor diff --git a/include/deal.II/matrix_free/portable_tensor_product_kernels.h b/include/deal.II/matrix_free/portable_tensor_product_kernels.h index f34bc2ff91..b340b68327 100644 --- a/include/deal.II/matrix_free/portable_tensor_product_kernels.h +++ b/include/deal.II/matrix_free/portable_tensor_product_kernels.h @@ -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 struct EvaluatorTensorProduct class DataOut : public dealii::DataOutInterface<0, spacedim> diff --git a/include/deal.II/particles/particle.h b/include/deal.II/particles/particle.h index 8b57a6ba5c..29732b9cd8 100644 --- a/include/deal.II/particles/particle.h +++ b/include/deal.II/particles/particle.h @@ -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 class Particle diff --git a/include/deal.II/particles/particle_handler.h b/include/deal.II/particles/particle_handler.h index b3c4f0e533..ade085a03d 100644 --- a/include/deal.II/particles/particle_handler.h +++ b/include/deal.II/particles/particle_handler.h @@ -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 class ParticleHandler : public Subscriptor -- 2.39.5