From 8eb8784ffcd55df2afceac3a319d2426d10afefa Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Thu, 21 Jul 2022 17:41:26 -0400 Subject: [PATCH] epic doxygen fixes It turns out that grouping using @{ and @} only works if it is inside a doxygen comment like /** */ and not inside a normal comment /* */. This meant that most of our groupings were incorrect. - fix @{ and @} - avoid using /*! which is equivalent to /** - make some formatting prettier --- doc/doxygen/headers/iterators.h | 2 +- .../deal.II/algorithms/general_data_storage.h | 4 +- include/deal.II/base/convergence_table.h | 2 +- include/deal.II/base/data_out_base.h | 6 +- include/deal.II/base/exceptions.h | 4 +- include/deal.II/base/function_parser.h | 2 +- include/deal.II/base/mu_parser_internal.h | 2 +- include/deal.II/base/parameter_handler.h | 2 +- include/deal.II/base/patterns.h | 8 +- include/deal.II/base/qprojector.h | 9 +- include/deal.II/base/quadrature.h | 8 +- include/deal.II/base/quadrature_lib.h | 8 +- include/deal.II/base/quadrature_point_data.h | 8 +- include/deal.II/base/quadrature_selector.h | 2 +- include/deal.II/base/subscriptor.h | 6 +- include/deal.II/base/table_handler.h | 2 +- include/deal.II/base/tensor.h | 24 ++-- include/deal.II/base/tensor_function_parser.h | 2 +- include/deal.II/base/thread_local_storage.h | 6 +- include/deal.II/base/thread_management.h | 9 +- include/deal.II/base/vectorization.h | 14 +-- .../deal.II/differentiation/ad/ad_drivers.h | 104 +++++++++--------- .../deal.II/differentiation/ad/ad_helpers.h | 96 ++++++++-------- .../differentiation/sd/symengine_math.h | 16 +-- .../sd/symengine_number_types.h | 54 ++++----- .../differentiation/sd/symengine_optimizer.h | 22 ++-- .../sd/symengine_scalar_operations.h | 24 ++-- .../sd/symengine_tensor_operations.h | 24 ++-- include/deal.II/dofs/dof_tools.h | 4 +- include/deal.II/fe/fe.h | 14 +-- include/deal.II/fe/fe_abf.h | 8 +- include/deal.II/fe/fe_bernstein.h | 8 +- include/deal.II/fe/fe_dgp.h | 8 +- include/deal.II/fe/fe_dgp_monomial.h | 8 +- include/deal.II/fe/fe_dgp_nonparametric.h | 8 +- include/deal.II/fe/fe_dgq.h | 8 +- include/deal.II/fe/fe_enriched.h | 4 +- include/deal.II/fe/fe_interface_values.h | 52 ++++----- include/deal.II/fe/fe_nedelec.h | 8 +- include/deal.II/fe/fe_nedelec_sz.h | 8 +- include/deal.II/fe/fe_nothing.h | 8 +- include/deal.II/fe/fe_p1nc.h | 8 +- include/deal.II/fe/fe_poly.h | 8 +- include/deal.II/fe/fe_poly_face.h | 8 +- include/deal.II/fe/fe_q.h | 8 +- include/deal.II/fe/fe_q_base.h | 10 +- include/deal.II/fe/fe_q_bubbles.h | 8 +- include/deal.II/fe/fe_q_dg0.h | 8 +- include/deal.II/fe/fe_q_hierarchical.h | 10 +- include/deal.II/fe/fe_q_iso_q1.h | 10 +- include/deal.II/fe/fe_raviart_thomas.h | 8 +- include/deal.II/fe/fe_series.h | 8 +- include/deal.II/fe/fe_system.h | 2 +- include/deal.II/fe/fe_tools.h | 14 ++- include/deal.II/fe/fe_update_flags.h | 6 +- include/deal.II/fe/fe_values.h | 36 +++--- include/deal.II/fe/mapping_c1.h | 8 +- include/deal.II/fe/mapping_cartesian.h | 8 +- include/deal.II/fe/mapping_fe.h | 9 +- include/deal.II/fe/mapping_fe_field.h | 8 +- include/deal.II/fe/mapping_manifold.h | 9 +- include/deal.II/fe/mapping_q.h | 9 +- include/deal.II/fe/mapping_q1.h | 9 +- include/deal.II/fe/mapping_q1_eulerian.h | 8 +- include/deal.II/fe/mapping_q_cache.h | 9 +- include/deal.II/fe/mapping_q_eulerian.h | 8 +- include/deal.II/grid/grid_generator.h | 16 +-- include/deal.II/grid/grid_tools.h | 44 ++++---- include/deal.II/grid/tria_iterator.h | 20 ++-- include/deal.II/lac/block_indices.h | 8 +- include/deal.II/lac/block_linear_operator.h | 8 +- include/deal.II/lac/block_matrix_base.h | 9 +- include/deal.II/lac/block_sparse_matrix.h | 29 ++--- include/deal.II/lac/block_sparse_matrix_ez.h | 7 +- include/deal.II/lac/block_sparsity_pattern.h | 16 +-- include/deal.II/lac/block_vector.h | 9 +- include/deal.II/lac/block_vector_base.h | 9 +- include/deal.II/lac/chunk_sparse_matrix.h | 45 ++++---- include/deal.II/lac/chunk_sparsity_pattern.h | 9 +- .../deal.II/lac/constrained_linear_operator.h | 4 +- include/deal.II/lac/cuda_sparse_matrix.h | 24 ++-- .../deal.II/lac/dynamic_sparsity_pattern.h | 7 +- include/deal.II/lac/eigen.h | 8 +- include/deal.II/lac/exceptions.h | 4 +- include/deal.II/lac/full_matrix.h | 23 ++-- include/deal.II/lac/householder.h | 7 +- include/deal.II/lac/identity_matrix.h | 5 +- .../deal.II/lac/la_parallel_block_vector.h | 17 +-- include/deal.II/lac/la_parallel_vector.h | 31 +++--- include/deal.II/lac/la_vector.h | 7 +- include/deal.II/lac/linear_operator.h | 16 +-- include/deal.II/lac/packaged_operation.h | 12 +- .../deal.II/lac/petsc_block_sparse_matrix.h | 7 +- include/deal.II/lac/petsc_block_vector.h | 7 +- include/deal.II/lac/petsc_full_matrix.h | 7 +- include/deal.II/lac/petsc_sparse_matrix.h | 2 +- include/deal.II/lac/petsc_vector.h | 5 +- include/deal.II/lac/precondition.h | 7 +- include/deal.II/lac/precondition_block.h | 9 +- include/deal.II/lac/precondition_selector.h | 9 +- include/deal.II/lac/read_write_vector.h | 19 ++-- include/deal.II/lac/schur_complement.h | 8 +- include/deal.II/lac/solver_bicgstab.h | 8 +- include/deal.II/lac/solver_cg.h | 6 +- include/deal.II/lac/solver_control.h | 8 +- include/deal.II/lac/solver_fire.h | 8 +- include/deal.II/lac/solver_gmres.h | 8 +- include/deal.II/lac/solver_idr.h | 8 +- include/deal.II/lac/solver_minres.h | 10 +- include/deal.II/lac/solver_qmrs.h | 8 +- include/deal.II/lac/solver_richardson.h | 8 +- include/deal.II/lac/solver_selector.h | 8 +- include/deal.II/lac/sparse_decomposition.h | 9 +- include/deal.II/lac/sparse_ilu.h | 9 +- include/deal.II/lac/sparse_matrix.h | 38 +++---- include/deal.II/lac/sparse_matrix_ez.h | 38 +++---- include/deal.II/lac/sparse_mic.h | 9 +- include/deal.II/lac/sparse_vanka.h | 7 +- include/deal.II/lac/sparsity_pattern.h | 5 +- include/deal.II/lac/sparsity_tools.h | 5 +- include/deal.II/lac/tridiagonal_matrix.h | 29 ++--- .../lac/trilinos_block_sparse_matrix.h | 9 +- .../deal.II/lac/trilinos_linear_operator.h | 8 +- .../lac/trilinos_parallel_block_vector.h | 7 +- include/deal.II/lac/trilinos_precondition.h | 19 ++-- include/deal.II/lac/trilinos_sparse_matrix.h | 64 +++++------ .../deal.II/lac/trilinos_sparsity_pattern.h | 34 +++--- include/deal.II/lac/trilinos_vector.h | 18 +-- include/deal.II/lac/vector.h | 36 +++--- include/deal.II/lac/vector_memory.h | 10 +- include/deal.II/lac/vector_operation.h | 7 +- include/deal.II/lac/vector_space_vector.h | 7 +- include/deal.II/matrix_free/fe_evaluation.h | 8 +- .../deal.II/matrix_free/fe_evaluation_data.h | 16 +-- include/deal.II/matrix_free/matrix_free.h | 20 ++-- include/deal.II/meshworker/assemble_flags.h | 8 +- include/deal.II/meshworker/integration_info.h | 6 +- include/deal.II/meshworker/scratch_data.h | 4 +- include/deal.II/multigrid/mg_base.h | 9 +- include/deal.II/multigrid/mg_block_smoother.h | 6 +- include/deal.II/multigrid/mg_coarse.h | 8 +- include/deal.II/multigrid/mg_matrix.h | 8 +- include/deal.II/multigrid/mg_smoother.h | 8 +- include/deal.II/multigrid/mg_tools.h | 2 +- include/deal.II/multigrid/mg_transfer.h | 10 +- include/deal.II/multigrid/mg_transfer_block.h | 8 +- .../deal.II/multigrid/mg_transfer_component.h | 8 +- .../multigrid/mg_transfer_matrix_free.h | 8 +- include/deal.II/multigrid/multigrid.h | 8 +- .../deal.II/numerics/vector_tools_boundary.h | 2 +- .../numerics/vector_tools_constraints.h | 4 +- .../vector_tools_integrate_difference.h | 4 +- .../numerics/vector_tools_interpolate.h | 8 +- .../numerics/vector_tools_mean_value.h | 4 +- .../numerics/vector_tools_point_gradient.h | 4 +- .../numerics/vector_tools_point_value.h | 6 +- .../deal.II/numerics/vector_tools_project.h | 2 +- include/deal.II/numerics/vector_tools_rhs.h | 2 +- include/deal.II/opencascade/manifold_lib.h | 2 +- .../deal.II/physics/elasticity/kinematics.h | 12 +- .../physics/elasticity/standard_tensors.h | 16 +-- include/deal.II/physics/notation.h | 8 +- include/deal.II/physics/transformations.h | 36 +++--- 163 files changed, 1085 insertions(+), 945 deletions(-) diff --git a/doc/doxygen/headers/iterators.h b/doc/doxygen/headers/iterators.h index ed085fc128..e745a344d3 100644 --- a/doc/doxygen/headers/iterators.h +++ b/doc/doxygen/headers/iterators.h @@ -383,7 +383,7 @@ levels, and accessors for objects of lower dimensionality do not have a @ingroup grid */ -//@} +/** @} */ /** diff --git a/include/deal.II/algorithms/general_data_storage.h b/include/deal.II/algorithms/general_data_storage.h index ac7dcac3ed..78b90d7a86 100644 --- a/include/deal.II/algorithms/general_data_storage.h +++ b/include/deal.II/algorithms/general_data_storage.h @@ -177,8 +177,8 @@ public: /** * @name Data storage and access + * @{ */ - //@{ /** * Store internally a copy of the given object. The copied object is @@ -327,7 +327,7 @@ public: void remove_object_with_name(const std::string &name); - //@} + /** @} */ /** * An entry with this name does not exist in the internal boost::any map. diff --git a/include/deal.II/base/convergence_table.h b/include/deal.II/base/convergence_table.h index 5c105c2931..a6e2846565 100644 --- a/include/deal.II/base/convergence_table.h +++ b/include/deal.II/base/convergence_table.h @@ -213,7 +213,7 @@ public: DeclException1(ExcRateColumnAlreadyExists, std::string, << "Rate column <" << arg1 << "> does already exist."); - //@} + /** @} */ }; diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index 3027abb5e2..5011030015 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -401,7 +401,7 @@ namespace DataOutBase << "It is not possible to have a structural dimension of " << arg1 << " to be larger than the space dimension of the surrounding" << " space " << arg2); - //@} + /** @} */ }; @@ -553,7 +553,7 @@ namespace DataOutBase << "It is not possible to have a structural dimension of " << arg1 << " to be larger than the space dimension of the surrounding" << " space " << arg2); - //@} + /** @} */ }; @@ -2528,7 +2528,7 @@ namespace DataOutBase << "There was an error opening Tecplot file " << arg1 << " for output."); - //@} + /** @} */ } // namespace DataOutBase diff --git a/include/deal.II/base/exceptions.h b/include/deal.II/base/exceptions.h index 2f2499ea6b..b2412c3eb7 100644 --- a/include/deal.II/base/exceptions.h +++ b/include/deal.II/base/exceptions.h @@ -626,8 +626,8 @@ namespace StandardExceptions { /** * @addtogroup Exceptions + * @{ */ - //@{ /** * Exception denoting a division by zero. @@ -1139,7 +1139,7 @@ namespace StandardExceptions std::string, << "There was an error in a cuSPARSE function: " << arg1); #endif - //@} + /** @} */ /** * This function requires support for the Exodus II library. diff --git a/include/deal.II/base/function_parser.h b/include/deal.II/base/function_parser.h index f336760883..d2654c2b1e 100644 --- a/include/deal.II/base/function_parser.h +++ b/include/deal.II/base/function_parser.h @@ -368,7 +368,7 @@ public: << ") is not equal to the number of expressions (" << arg2 << ")."); - //@} + /** @} */ }; diff --git a/include/deal.II/base/mu_parser_internal.h b/include/deal.II/base/mu_parser_internal.h index 679473ae93..8103e6468e 100644 --- a/include/deal.II/base/mu_parser_internal.h +++ b/include/deal.II/base/mu_parser_internal.h @@ -102,7 +102,7 @@ namespace internal << "Parsing Error at Column " << arg1 << ". The parser said: " << arg2); - //@} + /** @} */ /** * deal.II uses muParser as a purely internal dependency. To this end, we do diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index 3caf72b6ac..ac91eaeadc 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -1716,7 +1716,7 @@ public: "file to include <" << arg3 << "> cannot be opened."); - //@} + /** @} */ private: /** diff --git a/include/deal.II/base/patterns.h b/include/deal.II/base/patterns.h index a011377071..5d45d09c1b 100644 --- a/include/deal.II/base/patterns.h +++ b/include/deal.II/base/patterns.h @@ -538,7 +538,7 @@ namespace Patterns int, << "The values " << arg1 << " and " << arg2 << " do not form a valid range."); - //@} + /** @} */ private: /** * Copy of the pattern that each element of the list has to satisfy. @@ -685,7 +685,7 @@ namespace Patterns int, << "The values " << arg1 << " and " << arg2 << " do not form a valid range."); - //@} + /** @} */ private: /** * Copy of the patterns that each key and each value of the map has to @@ -960,7 +960,7 @@ namespace Patterns int, << "A comma was found at position " << arg1 << " of your input string, but commas are not allowed here."); - //@} + /** @} */ private: /** * List of valid strings as passed to the constructor. We don't make this @@ -1404,7 +1404,7 @@ namespace Patterns std::string, << "The string \"" << arg1 << "\" does not match the pattern \"" << arg2 << "\""); - //@} + /** @} */ } // namespace Tools } // namespace Patterns diff --git a/include/deal.II/base/qprojector.h b/include/deal.II/base/qprojector.h index 45c98f972a..a30dd2b3aa 100644 --- a/include/deal.II/base/qprojector.h +++ b/include/deal.II/base/qprojector.h @@ -29,9 +29,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Quadrature */ -/*@{*/ - +/** + * @addtogroup Quadrature + * @{ + */ /** * This class is a helper class to facilitate the usage of quadrature formulae @@ -333,7 +334,7 @@ public: }; }; -/*@}*/ +/** @} */ // ------------------- inline and template functions ---------------- diff --git a/include/deal.II/base/quadrature.h b/include/deal.II/base/quadrature.h index 04138d2a8e..d1013e76b9 100644 --- a/include/deal.II/base/quadrature.h +++ b/include/deal.II/base/quadrature.h @@ -28,8 +28,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Quadrature */ -/*@{*/ +/** + * @addtogroup Quadrature + * @{ + */ /** * Base class for quadrature formulae in arbitrary dimensions. This class @@ -403,7 +405,7 @@ public: -/*@}*/ +/** @} */ #ifndef DOXYGEN diff --git a/include/deal.II/base/quadrature_lib.h b/include/deal.II/base/quadrature_lib.h index 87b2718a06..01669fa365 100644 --- a/include/deal.II/base/quadrature_lib.h +++ b/include/deal.II/base/quadrature_lib.h @@ -23,8 +23,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Quadrature */ -/*@{*/ +/** + * @addtogroup Quadrature + * @{ + */ /** * The Gauss-Legendre family of quadrature rules for numerical integration. @@ -908,7 +910,7 @@ public: explicit QGaussPyramid(const unsigned int n_points_1D); }; -/*@}*/ +/** @} */ /* -------------- declaration of explicit specializations ------------- */ diff --git a/include/deal.II/base/quadrature_point_data.h b/include/deal.II/base/quadrature_point_data.h index f64933bffc..2927a841d9 100644 --- a/include/deal.II/base/quadrature_point_data.h +++ b/include/deal.II/base/quadrature_point_data.h @@ -38,8 +38,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Quadrature */ -/*@{*/ +/** + * @addtogroup Quadrature + * @{ + */ /** * A class for storing at each cell represented by iterators of type @p CellIteratorType @@ -587,7 +589,7 @@ namespace parallel #endif -/*@}*/ +/** @} */ #ifndef DOXYGEN diff --git a/include/deal.II/base/quadrature_selector.h b/include/deal.II/base/quadrature_selector.h index f00defadff..bda00c967c 100644 --- a/include/deal.II/base/quadrature_selector.h +++ b/include/deal.II/base/quadrature_selector.h @@ -87,7 +87,7 @@ public: DeclException1(ExcInvalidQuadrature, std::string, << arg1 << " is not a valid name for a quadrature rule."); - //@} + /** @} */ private: /** * This static function creates a quadrature object according to the name diff --git a/include/deal.II/base/subscriptor.h b/include/deal.II/base/subscriptor.h index efb009547b..b1d787b2b2 100644 --- a/include/deal.II/base/subscriptor.h +++ b/include/deal.II/base/subscriptor.h @@ -106,8 +106,8 @@ public: * * Classes derived from Subscriptor provide a facility to subscribe to this * object. This is mostly used by the SmartPointer class. + * @{ */ - // @{ /** * Subscribes a user of the object by storing the pointer @p validity. The @@ -148,7 +148,7 @@ public: void list_subscribers() const; - // @} + /** @} */ /** * @addtogroup Exceptions @@ -181,7 +181,7 @@ public: << "No subscriber with identifier <" << arg2 << "> subscribes to this object of class " << arg1 << ". Consequently, it cannot be unsubscribed."); - //@} + /** @} */ /** * Read or write the data of this object to or from a stream for the purpose diff --git a/include/deal.II/base/table_handler.h b/include/deal.II/base/table_handler.h index 451cc2c180..15cf1e7f20 100644 --- a/include/deal.II/base/table_handler.h +++ b/include/deal.II/base/table_handler.h @@ -620,7 +620,7 @@ public: << '<' << arg1 << "> is not a tex column format. Use " << "'l', 'c', or 'r' to indicate left, centered, or " << "right aligned text."); - //@} + /** @} */ protected: /** * Structure encapsulating all the data that is needed to describe one diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index c9798ba383..4cde9bde18 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -1889,8 +1889,8 @@ constexpr unsigned int Tensor::n_independent_components; /** * @name Output functions for Tensor objects + * @{ */ -//@{ /** * Output operator for tensors. Print the elements consecutively, with a space @@ -1929,12 +1929,11 @@ operator<<(std::ostream &out, const Tensor<0, dim, Number> &p) } -//@} +/** @} */ /** * @name Vector space operations on Tensor objects: + * @{ */ -//@{ - /** * Scalar multiplication of a tensor of rank 0 with an object from the left. @@ -2270,12 +2269,11 @@ inline constexpr DEAL_II_ALWAYS_INLINE return tmp; } -//@} +/** @} */ /** * @name Contraction operations and the outer product for tensor objects + * @{ */ -//@{ - /** * The dot product (single contraction) for tensors. This function return a @@ -2613,12 +2611,11 @@ constexpr inline DEAL_II_ALWAYS_INLINE } -//@} +/** @} */ /** * @name Special operations on tensors of rank 1 + * @{ */ -//@{ - /** * Return the cross product in 2d. This is just a rotation by 90 degrees @@ -2677,12 +2674,11 @@ constexpr inline DEAL_II_ALWAYS_INLINE } -//@} +/** @} */ /** * @name Special operations on tensors of rank 2 + * @{ */ -//@{ - /** * Compute the determinant of a tensor or rank 2. @@ -3048,7 +3044,7 @@ linfty_norm(const Tensor<2, dim, Number> &t) return max; } -//@} +/** @} */ #ifndef DOXYGEN diff --git a/include/deal.II/base/tensor_function_parser.h b/include/deal.II/base/tensor_function_parser.h index 969eb4b36a..ea316d31b8 100644 --- a/include/deal.II/base/tensor_function_parser.h +++ b/include/deal.II/base/tensor_function_parser.h @@ -260,7 +260,7 @@ public: << ") is not equal to the number of expressions (" << arg2 << ")."); - //@} + /** @} */ private: /** * Number of components is equal dimrank. diff --git a/include/deal.II/base/thread_local_storage.h b/include/deal.II/base/thread_local_storage.h index 6da118575b..d7d5814fad 100644 --- a/include/deal.II/base/thread_local_storage.h +++ b/include/deal.II/base/thread_local_storage.h @@ -31,8 +31,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup threads */ -/*@{*/ +/** + * @addtogroup threads + * @{ + */ # ifndef DOXYGEN class LogStream; diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index fd8e2d12a6..2929308f3d 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -42,9 +42,10 @@ DEAL_II_ENABLE_EXTRA_DIAGNOSTICS DEAL_II_NAMESPACE_OPEN -/*!@addtogroup threads */ -/*@{*/ - +/** + * @addtogroup threads + * @{ + */ /** * A namespace for the implementation of thread management in deal.II. Most of @@ -1300,7 +1301,7 @@ namespace Threads "The current object is not associated with a task that " "can be joined. It may have been detached, or you " "may have already joined it in the past."); - //@} + /** @} */ private: /** * A data structure that holds a std::future into which the task deposits diff --git a/include/deal.II/base/vectorization.h b/include/deal.II/base/vectorization.h index 02a02d73fb..9f58637911 100644 --- a/include/deal.II/base/vectorization.h +++ b/include/deal.II/base/vectorization.h @@ -729,9 +729,8 @@ private: /** * @name Packing and unpacking of a VectorizedArray + * @{ */ -//@{ - /** * Create a vectorized array that sets all entries in the array to the given @@ -944,7 +943,7 @@ vectorized_transpose_and_store(const bool add_into, } -//@} +/** @} */ #ifndef DOXYGEN @@ -4696,8 +4695,8 @@ private: /** * @name Arithmetic operations with VectorizedArray + * @{ */ -//@{ /** * Relational operator == for VectorizedArray @@ -5052,13 +5051,12 @@ operator<<(std::ostream &out, const VectorizedArray &p) return out; } -//@} +/** @} */ /** * @name Ternary operations on VectorizedArray + * @{ */ -//@{ - /** * enum class encoding binary operations for a component-wise comparison of @@ -5203,7 +5201,7 @@ compare_and_apply_mask(const VectorizedArray &left, return result; } -//@} +/** @} */ #ifndef DOXYGEN # if DEAL_II_VECTORIZATION_WIDTH_IN_BITS >= 512 && defined(__AVX512F__) diff --git a/include/deal.II/differentiation/ad/ad_drivers.h b/include/deal.II/differentiation/ad/ad_drivers.h index d6820f2c0f..ba25b55419 100644 --- a/include/deal.II/differentiation/ad/ad_drivers.h +++ b/include/deal.II/differentiation/ad/ad_drivers.h @@ -47,8 +47,8 @@ namespace Differentiation { /** * @addtogroup Exceptions + * @{ */ - //@{ /** * Exception denoting that a class requires some specialization @@ -83,7 +83,7 @@ namespace Differentiation << ", but to perform the intended operation the number must support at least " << arg2 << " levels."); - //@} + /** @} */ /** @@ -153,8 +153,8 @@ namespace Differentiation /** * @name Taping + * @{ */ - //@{ /** * Return whether or not this class is tracking calculations performed @@ -388,12 +388,12 @@ namespace Differentiation const typename Types::tape_index tape_index, std::ostream & stream) const; - //@} + /** @} */ /** * @name Drivers for scalar functions (one dependent variable) + * @{ */ - //@{ /** * Compute the value of the scalar field. @@ -445,12 +445,12 @@ namespace Differentiation const std::vector &independent_variables, FullMatrix & hessian) const; - //@} + /** @} */ /** * @name Drivers for vector functions (multiple dependent variables) + * @{ */ - //@{ /** * Compute the values of the vector field. @@ -494,7 +494,7 @@ namespace Differentiation const std::vector &independent_variables, FullMatrix & jacobian) const; - //@} + /** @} */ }; @@ -523,8 +523,8 @@ namespace Differentiation /** * @name Configuration + * @{ */ - //@{ /** * In the event that the tapeless mode requires a priori knowledge @@ -546,12 +546,12 @@ namespace Differentiation static void initialize_global_environment(const unsigned int n_independent_variables); - //@} + /** @} */ /** * Operation status + * @{ */ - //@{ /** * Set a flag that states that we can safely mark dependent variables @@ -574,12 +574,12 @@ namespace Differentiation bool is_dependent_variable_marking_allowed() const; - //@} + /** @} */ /** * @name Drivers for scalar functions + * @{ */ - //@{ /** * Compute the value of the scalar field. @@ -628,12 +628,12 @@ namespace Differentiation const std::vector &dependent_variables, FullMatrix & hessian) const; - //@} + /** @} */ /** * @name Drivers for vector functions + * @{ */ - //@{ /** * Compute the values of the vector field. @@ -670,7 +670,7 @@ namespace Differentiation const std::vector &dependent_variables, FullMatrix & jacobian) const; - //@} + /** @} */ }; } // namespace AD @@ -776,8 +776,8 @@ namespace Differentiation /** * @name Taping + * @{ */ - //@{ bool is_recording() const; @@ -835,12 +835,12 @@ namespace Differentiation const typename Types::tape_index tape_index, std::ostream & stream) const; - //@} + /** @} */ /** * @name Drivers for scalar functions (one dependent variable) + * @{ */ - //@{ scalar_type value(const typename Types::tape_index active_tape_index, @@ -856,12 +856,12 @@ namespace Differentiation const std::vector &independent_variables, FullMatrix & hessian) const; - //@} + /** @} */ /** * @name Drivers for vector functions (multiple dependent variables) + * @{ */ - //@{ void values(const typename Types::tape_index active_tape_index, @@ -875,7 +875,7 @@ namespace Differentiation const std::vector &independent_variables, FullMatrix & jacobian) const; - //@} + /** @} */ protected: /** @@ -977,8 +977,8 @@ namespace Differentiation /** * @name Taping + * @{ */ - //@{ bool is_recording() const; @@ -1031,12 +1031,12 @@ namespace Differentiation print_tape_stats(const typename Types::tape_index, std::ostream &) const; - //@} + /** @} */ /** * @name Drivers for scalar functions (one dependent variable) + * @{ */ - //@{ scalar_type value(const typename Types::tape_index, @@ -1052,12 +1052,12 @@ namespace Differentiation const std::vector &, FullMatrix &) const; - //@} + /** @} */ /** * @name Drivers for vector functions (multiple dependent variables) + * @{ */ - //@{ void values(const typename Types::tape_index, @@ -1071,7 +1071,7 @@ namespace Differentiation const std::vector &, FullMatrix &) const; - //@} + /** @} */ }; # endif // DEAL_II_WITH_ADOLC @@ -1095,8 +1095,8 @@ namespace Differentiation /** * @name Taping + * @{ */ - //@{ bool is_recording() const; @@ -1154,12 +1154,12 @@ namespace Differentiation const typename Types::tape_index tape_index, std::ostream & stream) const; - //@} + /** @} */ /** * @name Drivers for scalar functions (one dependent variable) + * @{ */ - //@{ scalar_type value(const typename Types::tape_index active_tape_index, @@ -1175,12 +1175,12 @@ namespace Differentiation const std::vector &independent_variables, FullMatrix & hessian) const; - //@} + /** @} */ /** * @name Drivers for vector functions (multiple dependent variables) + * @{ */ - //@{ void values(const typename Types::tape_index active_tape_index, @@ -1194,7 +1194,7 @@ namespace Differentiation const std::vector &independent_variables, FullMatrix & jacobian) const; - //@} + /** @} */ private: /** @@ -1234,18 +1234,18 @@ namespace Differentiation /** * @name Configuration + * @{ */ - //@{ static void initialize_global_environment(const unsigned int n_independent_variables); - //@} + /** @} */ /** - * Operation status + * @name Operation status + * @{ */ - //@{ void allow_dependent_variable_marking(); @@ -1256,12 +1256,12 @@ namespace Differentiation bool is_dependent_variable_marking_allowed() const; - //@} + /** @} */ /** * @name Drivers for scalar functions + * @{ */ - //@{ ScalarType value(const std::vector &dependent_variables) const; @@ -1276,12 +1276,12 @@ namespace Differentiation const std::vector &dependent_variables, FullMatrix & hessian) const; - //@} + /** @} */ /** * @name Drivers for vector functions + * @{ */ - //@{ void values(const std::vector &dependent_variables, @@ -1292,7 +1292,7 @@ namespace Differentiation const std::vector &dependent_variables, FullMatrix & jacobian) const; - //@} + /** @} */ private: /** @@ -1326,18 +1326,18 @@ namespace Differentiation /** * @name Configuration + * @{ */ - //@{ static void initialize_global_environment(const unsigned int n_independent_variables); - //@} + /** @} */ /** - * Operation status + * @name Operation status + * @{ */ - //@{ void allow_dependent_variable_marking(); @@ -1348,12 +1348,12 @@ namespace Differentiation bool is_dependent_variable_marking_allowed() const; - //@} + /** @} */ /** * @name Drivers for scalar functions + * @{ */ - //@{ ScalarType value(const std::vector &dependent_variables) const; @@ -1368,12 +1368,12 @@ namespace Differentiation const std::vector &dependent_variables, FullMatrix & hessian) const; - //@} + /** @} */ /** * @name Drivers for vector functions + * @{ */ - //@{ void values(const std::vector &dependent_variables, @@ -1384,7 +1384,7 @@ namespace Differentiation const std::vector &dependent_variables, FullMatrix & jacobian) const; - //@} + /** @} */ private: /** diff --git a/include/deal.II/differentiation/ad/ad_helpers.h b/include/deal.II/differentiation/ad/ad_helpers.h index 3a8c1dafb7..ebf4cfd287 100644 --- a/include/deal.II/differentiation/ad/ad_helpers.h +++ b/include/deal.II/differentiation/ad/ad_helpers.h @@ -186,8 +186,8 @@ namespace Differentiation /** * @name Constructor / destructor + * @{ */ - //@{ /** * The constructor for the class. @@ -211,12 +211,12 @@ namespace Differentiation */ virtual ~HelperBase() = default; - //@} + /** @} */ /** * @name Interrogation of internal information + * @{ */ - //@{ /** * Return the number of independent variables that this object expects to @@ -266,12 +266,12 @@ namespace Differentiation print_tape_stats(const typename Types::tape_index tape_index, std::ostream & stream) const; - //@} + /** @} */ /** * @name Operations specific to tapeless mode + * @{ */ - //@{ /** * Pre-specify the number of @p independent_variables to be used in @@ -295,12 +295,12 @@ namespace Differentiation configure_tapeless_mode(const unsigned int n_independent_variables, const bool ensure_persistent_setting = true); - //@} + /** @} */ /** * @name Operations specific to taped mode: Recording tapes + * @{ */ - //@{ /** * Reset the state of the helper class. @@ -575,13 +575,13 @@ namespace Differentiation void clear_active_tape(); - //@} + /** @} */ protected: /** * @name Drivers and taping + * @{ */ - //@{ /** * An object used to help manage stored tapes. @@ -619,12 +619,12 @@ namespace Differentiation activate_tape(const typename Types::tape_index tape_index, const bool read_mode); - //@} + /** @} */ /** * @name Independent variables + * @{ */ - //@{ /** * A set of independent variables $\mathbf{X}$ that differentiation will @@ -728,12 +728,12 @@ namespace Differentiation unsigned int n_registered_independent_variables() const; - //@} + /** @} */ /** * @name Dependent variables + * @{ */ - //@{ /** * The set of dependent variables $\mathbf{f}(\mathbf{X})$ of which the @@ -784,7 +784,7 @@ namespace Differentiation register_dependent_variable(const unsigned int index, const ad_type & func); - //@} + /** @} */ }; // class HelperBase @@ -853,7 +853,7 @@ namespace Differentiation /** * @name Constructor / destructor */ - //@{ + /** @{ */ /** * The constructor for the class. @@ -877,12 +877,12 @@ namespace Differentiation */ virtual ~CellLevelBase() = default; - //@} + /** @} */ /** * @name Independent variables */ - //@{ + /** @{ */ /** * Register the complete set of independent variables $\mathbf{X}$ that @@ -951,12 +951,12 @@ namespace Differentiation const std::vector & get_sensitive_dof_values() const; - //@} + /** @} */ /** * @name Operations specific to taped mode: Reusing tapes */ - //@{ + /** @{ */ /** * Set the values for the independent variables $\mathbf{X}$, i.e., the @@ -1003,12 +1003,12 @@ namespace Differentiation const VectorType & values, const std::vector &local_dof_indices); - //@} + /** @} */ /** * @name Dependent variables */ - //@{ + /** @{ */ /** * Compute the value of the residual vector field @@ -1047,7 +1047,7 @@ namespace Differentiation virtual void compute_linearization(FullMatrix &linearization) const = 0; - //@} + /** @} */ }; // class CellLevelBase @@ -1235,7 +1235,7 @@ namespace Differentiation /** * @name Constructor / destructor */ - //@{ + /** @{ */ /** * The constructor for the class. @@ -1259,12 +1259,12 @@ namespace Differentiation */ virtual ~EnergyFunctional() = default; - //@} + /** @} */ /** * @name Dependent variables */ - //@{ + /** @{ */ /** * Register the definition of the total cell energy @@ -1344,7 +1344,7 @@ namespace Differentiation compute_linearization( FullMatrix &linearization) const override; - //@} + /** @} */ }; // class EnergyFunctional @@ -1547,7 +1547,7 @@ namespace Differentiation /** * @name Constructor / destructor */ - //@{ + /** @{ */ /** * The constructor for the class. @@ -1571,12 +1571,12 @@ namespace Differentiation */ virtual ~ResidualLinearization() = default; - //@} + /** @} */ /** * @name Dependent variables */ - //@{ + /** @{ */ /** * Register the definition of the cell residual vector @@ -1634,7 +1634,7 @@ namespace Differentiation compute_linearization( FullMatrix &linearization) const override; - //@} + /** @} */ }; // class ResidualLinearization @@ -2665,7 +2665,7 @@ namespace Differentiation /** * @name Constructor / destructor */ - //@{ + /** @{ */ /** * The constructor for the class. @@ -2689,12 +2689,12 @@ namespace Differentiation */ virtual ~PointLevelFunctionsBase() = default; - //@} + /** @} */ /** * @name Independent variables */ - //@{ + /** @{ */ /** * @copydoc HelperBase::reset() @@ -2810,12 +2810,12 @@ namespace Differentiation ExtractorType>::template tensor_type get_sensitive_variables(const ExtractorType &extractor) const; - //@} + /** @} */ /** * @name Operations specific to taped mode: Reusing tapes */ - //@{ + /** @{ */ /** * Set the values for the independent variables $\mathbf{X}$. @@ -2868,13 +2868,13 @@ namespace Differentiation set_independent_variable(const ValueType & value, const ExtractorType &extractor); - //@} + /** @} */ protected: /** * @name Independent variables */ - //@{ + /** @{ */ /** * Set the actual value of the independent variable $X_{i}$. @@ -2906,13 +2906,13 @@ namespace Differentiation unsigned int n_symmetric_independent_variables() const; - //@} + /** @} */ private: /** * @name Independent variables */ - //@{ + /** @{ */ /** * The independent variables for which we must take into account symmetry @@ -2920,7 +2920,7 @@ namespace Differentiation */ std::vector symmetric_independent_variables; - //@} + /** @} */ }; // class PointLevelFunctionsBase @@ -3104,7 +3104,7 @@ namespace Differentiation /** * @name Constructor / destructor */ - //@{ + /** @{ */ /** * The constructor for the class. @@ -3122,12 +3122,12 @@ namespace Differentiation */ virtual ~ScalarFunction() = default; - //@} + /** @} */ /** * @name Dependent variables */ - //@{ + /** @{ */ /** * Register the definition of the scalar field $\Psi(\mathbf{X})$. @@ -3308,7 +3308,7 @@ namespace Differentiation const FEValuesExtractors::SymmetricTensor<2> &extractor_row, const FEValuesExtractors::SymmetricTensor<2> &extractor_col); - //@} + /** @} */ }; // class ScalarFunction @@ -3495,7 +3495,7 @@ namespace Differentiation /** * @name Constructor / destructor */ - //@{ + /** @{ */ /** * The constructor for the class. @@ -3519,12 +3519,12 @@ namespace Differentiation */ virtual ~VectorFunction() = default; - //@} + /** @} */ /** * @name Dependent variables */ - //@{ + /** @{ */ /** * Register the definition of the vector field @@ -3707,7 +3707,7 @@ namespace Differentiation const FEValuesExtractors::SymmetricTensor<2> &extractor_row, const FEValuesExtractors::SymmetricTensor<2> &extractor_col); - //@} + /** @} */ }; // class VectorFunction diff --git a/include/deal.II/differentiation/sd/symengine_math.h b/include/deal.II/differentiation/sd/symengine_math.h index 38b7c7e471..9bdd112d53 100644 --- a/include/deal.II/differentiation/sd/symengine_math.h +++ b/include/deal.II/differentiation/sd/symengine_math.h @@ -46,7 +46,7 @@ namespace Differentiation /** * @name Power functions */ - //@{ + /** @{ */ /** * Return a symbolic number that represents a @p base value raised to the power of @@ -190,12 +190,12 @@ namespace Differentiation Expression log10(const Expression &x); - //@} + /** @} */ /** * @name Trigonometric functions */ - //@{ + /** @{ */ /** * Return a symbolic number that represents the sine function with the @@ -374,12 +374,12 @@ namespace Differentiation Expression acot(const Expression &x); - //@} + /** @} */ /** * @name Hyperbolic trigonometric functions */ - //@{ + /** @{ */ /** * Return a symbolic number that represents the hyperbolic sine function @@ -513,12 +513,12 @@ namespace Differentiation Expression acoth(const Expression &x); - //@} + /** @} */ /** * @name Other functions */ - //@{ + /** @{ */ /** * Return a symbolic number that represents the absolute value of value @p x. @@ -697,7 +697,7 @@ namespace Differentiation Expression erfc(const Expression &x); - //@} + /** @} */ } // namespace SD } // namespace Differentiation diff --git a/include/deal.II/differentiation/sd/symengine_number_types.h b/include/deal.II/differentiation/sd/symengine_number_types.h index a90c29470b..2620db3a88 100644 --- a/include/deal.II/differentiation/sd/symengine_number_types.h +++ b/include/deal.II/differentiation/sd/symengine_number_types.h @@ -86,7 +86,7 @@ namespace Differentiation << "previously declared all symbolic variables that are present " << "in the expression?"); - //@} + /** @} */ /** * A class to wrap SymEngine expressions. @@ -180,7 +180,7 @@ namespace Differentiation /** * @name Constructors */ - //@{ + /** @{ */ /** * Default constructor. @@ -405,12 +405,12 @@ namespace Differentiation */ virtual ~Expression() = default; - //@} + /** @} */ /** * Utilities */ - //@{ + /** @{ */ /** * Parse an expression from a string representing a symbolic @p expression. @@ -503,12 +503,12 @@ namespace Differentiation BOOST_SERIALIZATION_SPLIT_MEMBER() # endif - //@} + /** @} */ /** * @name Values */ - //@{ + /** @{ */ /** * Return the value or expression that this class instance represents. @@ -530,12 +530,12 @@ namespace Differentiation const SymEngine::RCP & get_RCP() const; - //@} + /** @} */ /** * @name Math and relational operators with (potentially) symbolic types */ - //@{ + /** @{ */ /** * Assignment operator. @@ -591,12 +591,12 @@ namespace Differentiation Expression & operator/=(const Expression &rhs); - //@} + /** @} */ /** * @name Math and relational operators with numeric types */ - //@{ + /** @{ */ /** * Assignment operator. @@ -659,12 +659,12 @@ namespace Differentiation Expression & operator/=(const NumberType &rhs); - //@} + /** @} */ /** * @name Differentiation */ - //@{ + /** @{ */ /** * Return the derivative of this object's @p expression @@ -688,12 +688,12 @@ namespace Differentiation Expression differentiate(const SymEngine::RCP &symbol) const; - //@} + /** @} */ /** * @name Dictionary-based substitution */ - //@{ + /** @{ */ /** * Perform substitution of all symbols found in this object's @p expression @@ -782,12 +782,12 @@ namespace Differentiation substitute_and_evaluate( const SymEngine::map_basic_basic &substitution_values) const; - //@} + /** @} */ /** * @name Conversion operators */ - //@{ + /** @{ */ /** * Conversion operator for real integer or floating point values, and @@ -854,7 +854,7 @@ namespace Differentiation */ operator const SymEngine::RCP &() const; - //@} + /** @} */ protected: /** @@ -874,7 +874,7 @@ namespace Differentiation /** * @name Type traits */ - //@{ + /** @{ */ /** * A struct to indicate whether a given @p NumberType is a supported @@ -895,12 +895,12 @@ namespace Differentiation struct is_sd_number : std::true_type {}; - //@} + /** @} */ /** * @name Bitwise operators */ - //@{ + /** @{ */ /** * Bitwise left shift operator. @@ -918,12 +918,12 @@ namespace Differentiation std::istream & operator>>(std::istream &stream, Expression &expression); - //@} + /** @} */ /** * @name Comparison operators */ - //@{ + /** @{ */ /** * Equality operator. @@ -973,12 +973,12 @@ namespace Differentiation Expression operator>=(const Expression &lhs, const Expression &rhs); - //@} + /** @} */ /** * @name Logical operators */ - //@{ + /** @{ */ /** * Logical not operator. @@ -1036,12 +1036,12 @@ namespace Differentiation Expression operator||(const Expression &lhs, const Expression &rhs); - //@} + /** @} */ /** * @name Mathematical operators */ - //@{ + /** @{ */ /** * Addition operator. @@ -1211,7 +1211,7 @@ namespace Differentiation return lhs / Expression(rhs); } - //@} + /** @} */ } // namespace SD } // namespace Differentiation diff --git a/include/deal.II/differentiation/sd/symengine_optimizer.h b/include/deal.II/differentiation/sd/symengine_optimizer.h index caeddd3d81..527ed298a3 100644 --- a/include/deal.II/differentiation/sd/symengine_optimizer.h +++ b/include/deal.II/differentiation/sd/symengine_optimizer.h @@ -83,7 +83,7 @@ namespace Differentiation "The SymEngine LLVM optimizer does not (yet) support the " "selected return type."); - //@} + /** @} */ // Forward declarations @@ -1584,7 +1584,7 @@ namespace Differentiation /** * @name Independent variables */ - //@{ + /** @{ */ /** * Register a collection of symbols that represents an independent @@ -1643,12 +1643,12 @@ namespace Differentiation std::size_t n_independent_variables() const; - //@} + /** @} */ /** * @name Dependent variables */ - //@{ + /** @{ */ /** * Register a scalar symbolic expression that represents a dependent @@ -1734,12 +1734,12 @@ namespace Differentiation std::size_t n_dependent_variables() const; - //@} + /** @} */ /** * @name Optimization */ - //@{ + /** @{ */ /** * Select the @p optimization_method for the batch optimizer to @@ -1804,12 +1804,12 @@ namespace Differentiation bool optimized() const; - //@} + /** @} */ /** * @name Symbol substitution */ - //@{ + /** @{ */ /** * Perform batch substitution of all of the registered symbols @@ -1871,12 +1871,12 @@ namespace Differentiation bool values_substituted() const; - //@} + /** @} */ /** * @name Evaluation / data extraction */ - //@{ + /** @{ */ /** * Returns the result of a value substitution into the optimized @@ -1999,7 +1999,7 @@ namespace Differentiation extract(const SymmetricTensor &funcs, const std::vector &cached_evaluation) const; - //@} + /** @} */ private: /** diff --git a/include/deal.II/differentiation/sd/symengine_scalar_operations.h b/include/deal.II/differentiation/sd/symengine_scalar_operations.h index 505376e77d..b3db90d27b 100644 --- a/include/deal.II/differentiation/sd/symengine_scalar_operations.h +++ b/include/deal.II/differentiation/sd/symengine_scalar_operations.h @@ -42,7 +42,7 @@ namespace Differentiation /** * @name Symbolic variable creation */ - //@{ + /** @{ */ /** * Return an Expression representing a scalar symbolic variable @@ -110,12 +110,12 @@ namespace Differentiation make_symbolic_function(const std::string & symbol, const types::substitution_map &arguments); - //@} + /** @} */ /** * @name Symbolic differentiation */ - //@{ + /** @{ */ /** * Return the symbolic result of computing the partial derivative of the @@ -131,12 +131,12 @@ namespace Differentiation Expression differentiate(const Expression &f, const Expression &x); - //@} + /** @} */ /** * @name Symbol map creation and manipulation */ - //@{ + /** @{ */ namespace internal { @@ -594,12 +594,12 @@ namespace Differentiation set_value_in_symbol_map(types::substitution_map & substitution_map, const types::substitution_map &symbol_values); - //@} + /** @} */ /** * @name Symbol substitution map creation */ - //@{ + /** @{ */ /** * Return a substitution map that has the entry key given by @p symbol @@ -782,12 +782,12 @@ namespace Differentiation const std::pair &symbol_value, const Args &...other_symbol_values); - //@} + /** @} */ /** * @name Symbol substitution map enlargement */ - //@{ + /** @{ */ namespace internal { @@ -1162,12 +1162,12 @@ namespace Differentiation merge_substitution_maps(const types::substitution_map &substitution_map_in, const Args &...other_substitution_maps_in); - //@} + /** @} */ /** * @name Symbol substitution and evaluation */ - //@{ + /** @{ */ /** * Return a substitution map that has any explicit interdependencies between @@ -1423,7 +1423,7 @@ namespace Differentiation substitute_and_evaluate(const Expression &expression, const Args &...symbol_values); - //@} + /** @} */ } // namespace SD } // namespace Differentiation diff --git a/include/deal.II/differentiation/sd/symengine_tensor_operations.h b/include/deal.II/differentiation/sd/symengine_tensor_operations.h index 1a617e2081..f1b7aac0c7 100644 --- a/include/deal.II/differentiation/sd/symengine_tensor_operations.h +++ b/include/deal.II/differentiation/sd/symengine_tensor_operations.h @@ -39,7 +39,7 @@ namespace Differentiation /** * @name Symbolic variable creation */ - //@{ + /** @{ */ /** * Return a vector of Expressions representing a vectorial symbolic @@ -184,12 +184,12 @@ namespace Differentiation const std::string & symbol, const types::substitution_map &arguments); - //@} + /** @} */ /** * @name Symbolic differentiation */ - //@{ + /** @{ */ /** * Return the symbolic result of computing the partial derivative of the @@ -367,12 +367,12 @@ namespace Differentiation differentiate(const SymmetricTensor &S, const Tensor & T); - //@} + /** @} */ /** * @name Symbol map creation and manipulation */ - //@{ + /** @{ */ /** * A convenience function for adding empty entries, with the key values @@ -495,12 +495,12 @@ namespace Differentiation const SymmetricTensor &symbol_tensor, const SymmetricTensor & value_tensor); - //@} + /** @} */ /** * @name Symbol substitution map creation */ - //@{ + /** @{ */ /** * Return a substitution map that has the entry keys given by the @@ -556,12 +556,12 @@ namespace Differentiation const SymmetricTensor &symbol_tensor, const SymmetricTensor & value_tensor); - //@} + /** @} */ /** * @name Symbol substitution map enlargement */ - //@{ + /** @{ */ /** * A convenience function for adding an entry to the @p substitution_map. @@ -636,12 +636,12 @@ namespace Differentiation const SymmetricTensor &symbol_tensor, const SymmetricTensor & value_tensor); - //@} + /** @} */ /** * @name Symbol substitution and evaluation */ - //@{ + /** @{ */ /** * Perform a single substitution sweep of a set of symbols into the given @@ -755,7 +755,7 @@ namespace Differentiation const SymmetricTensor &expression_tensor, const types::substitution_map & substitution_map); - //@} + /** @} */ } // namespace SD } // namespace Differentiation diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index 3e3b307930..d26eec2e40 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -1499,7 +1499,7 @@ namespace DoFTools extract_constant_modes(const DoFHandler &dof_handler, const ComponentMask & component_mask, std::vector> & constant_modes); - //@} + /** @} */ /** * @name Parallelization and domain decomposition @@ -1817,7 +1817,7 @@ namespace DoFTools * and related classes to implement Schwarz preconditioners and smoothers, * where the subdomains consist of small numbers of cells only. */ - //@{ + /** @{ */ /** * Return the set of degrees of freedom that live on a set of cells (i.e., a diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 0b818df32a..9ceacd17ad 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -1018,7 +1018,7 @@ public: has_support_on_face(const unsigned int shape_index, const unsigned int face_index) const; - //@} + /** @} */ /** * @name Transfer and constraint matrices * @{ @@ -1249,7 +1249,7 @@ public: virtual void get_interpolation_matrix(const FiniteElement &source, FullMatrix & matrix) const; - //@} + /** @} */ /** * @name Functions to support hp-adaptivity @@ -1290,7 +1290,7 @@ public: const unsigned int subface, FullMatrix & matrix, const unsigned int face_no = 0) const; - //@} + /** @} */ /** @@ -1350,7 +1350,7 @@ public: compare_for_domination(const FiniteElement &fe_other, const unsigned int codim = 0) const; - //@} + /** @} */ /** * Comparison operator. @@ -1795,7 +1795,7 @@ public: unsigned int component_to_block_index(const unsigned int component) const; - //@} + /** @} */ /** * @name Component and block matrices @@ -1971,7 +1971,7 @@ public: virtual std::pair, std::vector> get_constant_modes() const; - //@} + /** @} */ /** * @name Support points and interpolation @@ -2250,7 +2250,7 @@ public: const std::vector> &support_point_values, std::vector & nodal_values) const; - //@} + /** @} */ /** * Determine an estimate for the memory consumption (in bytes) of this diff --git a/include/deal.II/fe/fe_abf.h b/include/deal.II/fe/fe_abf.h index b170c180a0..5332dde9d5 100644 --- a/include/deal.II/fe/fe_abf.h +++ b/include/deal.II/fe/fe_abf.h @@ -32,8 +32,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of Arnold-Boffi-Falk (ABF) elements, conforming with the @@ -256,7 +258,7 @@ private: -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_bernstein.h b/include/deal.II/fe/fe_bernstein.h index 4d471eef78..c7d3740d2b 100644 --- a/include/deal.II/fe/fe_bernstein.h +++ b/include/deal.II/fe/fe_bernstein.h @@ -25,8 +25,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of a scalar Bernstein finite element @p that we call @@ -215,7 +217,7 @@ protected: -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_dgp.h b/include/deal.II/fe/fe_dgp.h index c244f435bf..c74cebcbe1 100644 --- a/include/deal.II/fe/fe_dgp.h +++ b/include/deal.II/fe/fe_dgp.h @@ -24,8 +24,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Discontinuous finite elements based on Legendre polynomials. @@ -468,7 +470,7 @@ private: get_dpo_vector(const unsigned int degree); }; -/* @} */ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_dgp_monomial.h b/include/deal.II/fe/fe_dgp_monomial.h index 833a5462c2..9cd3527651 100644 --- a/include/deal.II/fe/fe_dgp_monomial.h +++ b/include/deal.II/fe/fe_dgp_monomial.h @@ -24,8 +24,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Discontinuous finite elements based on monomials. @@ -452,7 +454,7 @@ private: initialize_restriction(); }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_dgp_nonparametric.h b/include/deal.II/fe/fe_dgp_nonparametric.h index 755f5d106c..76a32e8cbf 100644 --- a/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/include/deal.II/fe/fe_dgp_nonparametric.h @@ -26,8 +26,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Discontinuous finite elements evaluated at the mapped quadrature points. @@ -587,7 +589,7 @@ private: friend class FE_DGPNonparametric; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_dgq.h b/include/deal.II/fe/fe_dgq.h index a45310ed04..7665731953 100644 --- a/include/deal.II/fe/fe_dgq.h +++ b/include/deal.II/fe/fe_dgq.h @@ -33,8 +33,10 @@ template class Quadrature; #endif -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of scalar, discontinuous tensor product elements based on @@ -520,7 +522,7 @@ public: }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_enriched.h b/include/deal.II/fe/fe_enriched.h index 65bb51fe96..0d70f58d3a 100644 --- a/include/deal.II/fe/fe_enriched.h +++ b/include/deal.II/fe/fe_enriched.h @@ -329,7 +329,7 @@ public: const RefinementCase &refinement_case = RefinementCase::isotropic_refinement) const override; - //@} + /** @} */ /** * @name Functions to support hp @@ -423,7 +423,7 @@ public: compare_for_domination(const FiniteElement &fe_other, const unsigned int codim = 0) const override final; - //@} + /** @} */ /** diff --git a/include/deal.II/fe/fe_interface_values.h b/include/deal.II/fe/fe_interface_values.h index 3616755787..b45be9d32e 100644 --- a/include/deal.II/fe/fe_interface_values.h +++ b/include/deal.II/fe/fe_interface_values.h @@ -149,7 +149,7 @@ namespace FEInterfaceViews /** * @name Access to shape functions */ - //@{ + /** @{ */ /** * Return the value of the shape function @@ -175,12 +175,12 @@ namespace FEInterfaceViews const unsigned int interface_dof_index, const unsigned int q_point) const; - //@} + /** @} */ /** * @name Access to jumps in shape functions and their derivatives */ - //@{ + /** @{ */ /** * Return the jump $\jump{u}=u_1 - u_2$ on the interface for the shape @@ -278,12 +278,12 @@ namespace FEInterfaceViews jump_3rd_derivative(const unsigned int interface_dof_index, const unsigned int q_point) const; - //@} + /** @} */ /** * @name Access to the average of shape functions and their derivatives */ - //@{ + /** @{ */ /** * Return the average value $\average{u}=\frac{1}{2}(u_1 + u_2)$ on the @@ -368,12 +368,12 @@ namespace FEInterfaceViews average_hessian(const unsigned int interface_dof_index, const unsigned int q_point) const; - //@} + /** @} */ /** * @name Access to values of global finite element fields */ - //@{ + /** @{ */ /** * Return the values of the selected scalar component of the finite @@ -432,12 +432,12 @@ namespace FEInterfaceViews std::vector> &values) const; - //@} + /** @} */ /** * @name Access to jumps in global finite element fields */ - //@{ + /** @{ */ /** * Return the jump in the values of the selected scalar component of the @@ -578,12 +578,12 @@ namespace FEInterfaceViews solution_third_derivative_type> &third_derivatives) const; - //@} + /** @} */ /** * @name Access to the average of global finite element fields */ - //@{ + /** @{ */ /** * Return the average of the values of the selected scalar component of the @@ -687,7 +687,7 @@ namespace FEInterfaceViews std::vector> &hessians) const; - //@} + /** @} */ private: /** @@ -782,7 +782,7 @@ namespace FEInterfaceViews /** * @name Access to shape functions */ - //@{ + /** @{ */ /** * Return the value of the vector components selected by this view @@ -808,12 +808,12 @@ namespace FEInterfaceViews const unsigned int interface_dof_index, const unsigned int q_point) const; - //@} + /** @} */ /** * @name Access to jumps in shape functions and their derivatives */ - //@{ + /** @{ */ /** * Return the jump vector $[\mathbf{u}]=\mathbf{u_1} - \mathbf{u_2}$ on the @@ -907,12 +907,12 @@ namespace FEInterfaceViews jump_3rd_derivative(const unsigned int interface_dof_index, const unsigned int q_point) const; - //@} + /** @} */ /** * @name Access to the average of shape functions and their derivatives */ - //@{ + /** @{ */ /** * Return the average vector $\average{\mathbf{u}}=\frac{1}{2}(\mathbf{u_1} @@ -984,12 +984,12 @@ namespace FEInterfaceViews average_hessian(const unsigned int interface_dof_index, const unsigned int q_point) const; - //@} + /** @} */ /** * @name Access to values of global finite element fields */ - //@{ + /** @{ */ /** * Return the values of the selected vector component of the finite @@ -1048,12 +1048,12 @@ namespace FEInterfaceViews std::vector> &values) const; - //@} + /** @} */ /** * @name Access to jumps in global finite element fields */ - //@{ + /** @{ */ /** * Return the jump in the values of the selected vector component of the @@ -1194,12 +1194,12 @@ namespace FEInterfaceViews solution_third_derivative_type> &third_derivatives) const; - //@} + /** @} */ /** * @name Access to the average of global finite element fields */ - //@{ + /** @{ */ /** * Return the average of the values of the selected vector component of the @@ -1303,7 +1303,7 @@ namespace FEInterfaceViews std::vector> &hessians) const; - //@} + /** @} */ private: /** @@ -2019,12 +2019,12 @@ public: std::vector> &third_derivatives) const; - //@} + /** @} */ /** * @name Access to the average of the function values and derivatives */ - //@{ + /** @{ */ /** * Return the average of the values of the diff --git a/include/deal.II/fe/fe_nedelec.h b/include/deal.II/fe/fe_nedelec.h index 435e954e4a..ec2f223935 100644 --- a/include/deal.II/fe/fe_nedelec.h +++ b/include/deal.II/fe/fe_nedelec.h @@ -33,8 +33,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * @warning Several aspects of the implementation are experimental. For the @@ -663,7 +665,7 @@ FE_Nedelec<1>::initialize_restriction(); #endif // DOXYGEN -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_nedelec_sz.h b/include/deal.II/fe/fe_nedelec_sz.h index a77a547a82..043164c345 100644 --- a/include/deal.II/fe/fe_nedelec_sz.h +++ b/include/deal.II/fe/fe_nedelec_sz.h @@ -28,8 +28,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * This class represents an implementation of the @@ -458,7 +460,7 @@ private: -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_nothing.h b/include/deal.II/fe/fe_nothing.h index e5d879f333..a81cc64408 100644 --- a/include/deal.II/fe/fe_nothing.h +++ b/include/deal.II/fe/fe_nothing.h @@ -23,8 +23,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Definition of a finite element space with zero degrees of freedom and that, @@ -352,7 +354,7 @@ private: }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_p1nc.h b/include/deal.II/fe/fe_p1nc.h index a73cf033d1..c0d266e1ba 100644 --- a/include/deal.II/fe/fe_p1nc.h +++ b/include/deal.II/fe/fe_p1nc.h @@ -27,8 +27,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of the scalar version of the P1 nonconforming finite @@ -389,7 +391,7 @@ private: -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_poly.h b/include/deal.II/fe/fe_poly.h index 934388f757..7752b281f1 100644 --- a/include/deal.II/fe/fe_poly.h +++ b/include/deal.II/fe/fe_poly.h @@ -28,8 +28,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup febase */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * This class gives a unified framework for the implementation of @@ -534,7 +536,7 @@ protected: const std::unique_ptr> poly_space; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_poly_face.h b/include/deal.II/fe/fe_poly_face.h index d2348767f8..b1e1085ff6 100644 --- a/include/deal.II/fe/fe_poly_face.h +++ b/include/deal.II/fe/fe_poly_face.h @@ -27,8 +27,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup febase */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * @warning This class is not sufficiently tested yet! @@ -262,7 +264,7 @@ protected: PolynomialType poly_space; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_q.h b/include/deal.II/fe/fe_q.h index f451b7df8d..a799b9466c 100644 --- a/include/deal.II/fe/fe_q.h +++ b/include/deal.II/fe/fe_q.h @@ -25,8 +25,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of a scalar Lagrange finite element @p Qp that yields the @@ -633,7 +635,7 @@ public: -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_q_base.h b/include/deal.II/fe/fe_q_base.h index 9aa8986074..e9c70005ae 100644 --- a/include/deal.II/fe/fe_q_base.h +++ b/include/deal.II/fe/fe_q_base.h @@ -25,8 +25,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * This class collects the basic methods used in FE_Q, FE_Q_DG0 and @@ -260,7 +262,7 @@ public: hp_quad_dof_identities(const FiniteElement &fe_other, const unsigned int face_no = 0) const override; - //@} + /** @} */ /** * Attempt to construct an FE_Q object of degree 0 @@ -345,7 +347,7 @@ private: }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_q_bubbles.h b/include/deal.II/fe/fe_q_bubbles.h index 5aa094d146..7f7b7046aa 100644 --- a/include/deal.II/fe/fe_q_bubbles.h +++ b/include/deal.II/fe/fe_q_bubbles.h @@ -26,8 +26,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of a scalar Lagrange finite element $Q_p^+$ that yields the @@ -195,7 +197,7 @@ private: -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_q_dg0.h b/include/deal.II/fe/fe_q_dg0.h index 1719633d53..7f45c328dc 100644 --- a/include/deal.II/fe/fe_q_dg0.h +++ b/include/deal.II/fe/fe_q_dg0.h @@ -26,8 +26,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of a scalar Lagrange finite element @p Qp+DG0 that yields @@ -325,7 +327,7 @@ private: -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_q_hierarchical.h b/include/deal.II/fe/fe_q_hierarchical.h index 5ceb325039..adc9482078 100644 --- a/include/deal.II/fe/fe_q_hierarchical.h +++ b/include/deal.II/fe/fe_q_hierarchical.h @@ -24,8 +24,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of hierarchical @p Qp shape functions that yield the finite @@ -634,7 +636,7 @@ public: compare_for_domination(const FiniteElement &fe_other, const unsigned int codim = 0) const override final; - /*@}*/ + /** @} */ /** * Return the matrix interpolating from a face of one element to the face of @@ -793,7 +795,7 @@ private: friend class FE_Q_Hierarchical; }; -/*@}*/ +/** @} */ /* -------------- declaration of explicit specializations ------------- */ diff --git a/include/deal.II/fe/fe_q_iso_q1.h b/include/deal.II/fe/fe_q_iso_q1.h index 314e7621a0..e25255dda4 100644 --- a/include/deal.II/fe/fe_q_iso_q1.h +++ b/include/deal.II/fe/fe_q_iso_q1.h @@ -26,8 +26,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of a scalar Lagrange finite element @p Qp-iso-Q1 @@ -170,12 +172,12 @@ public: compare_for_domination(const FiniteElement &fe_other, const unsigned int codim = 0) const override final; - //@} + /** @} */ }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h index 1a4c77595f..e2852b4e6f 100644 --- a/include/deal.II/fe/fe_raviart_thomas.h +++ b/include/deal.II/fe/fe_raviart_thomas.h @@ -27,8 +27,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup fe */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** * Implementation of Raviart-Thomas (RT) elements. The Raviart-Thomas space @@ -420,7 +422,7 @@ private: mutable Threads::Mutex mutex; }; -/*@}*/ +/** @} */ /* -------------- declaration of explicit specializations ------------- */ diff --git a/include/deal.II/fe/fe_series.h b/include/deal.II/fe/fe_series.h index 814a86cf48..7e10c33f3e 100644 --- a/include/deal.II/fe/fe_series.h +++ b/include/deal.II/fe/fe_series.h @@ -42,8 +42,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup feall */ -/*@{*/ +/** + * @addtogroup fe + * @{ + */ /** @@ -412,7 +414,7 @@ namespace FESeries } // namespace FESeries -/*@}*/ +/** @} */ diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index 2a86623626..45194ce5c6 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -1017,7 +1017,7 @@ public: compare_for_domination(const FiniteElement &fe_other, const unsigned int codim = 0) const override final; - //@} + /** @} */ /** * Implementation of the diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index f8d2b0b9f6..b62f549df8 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -56,8 +56,10 @@ class AffineConstraints; #endif -/*!@addtogroup feall */ -/*@{*/ +/** + * @addtogroup feall + * @{ + */ /** @@ -610,11 +612,11 @@ namespace FETools - //@} + /** @} */ /** * @name Functions which should be in DoFTools */ - //@{ + /** @{ */ /** * Compute the interpolation of a the @p dof1-function @p u1 to a @p * dof2-function @p u2. @p dof1 and @p dof2 need to be DoFHandlers based on @@ -861,7 +863,7 @@ namespace FETools const AffineConstraints &constraints, OutVector & z2); - //@} + /** @} */ /** * The numbering of the degrees of freedom in continuous finite elements is * hierarchic, i.e. in such a way that we first number the vertex dofs, in @@ -1483,7 +1485,7 @@ namespace FETools #endif -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/fe_update_flags.h b/include/deal.II/fe/fe_update_flags.h index 38a0f71c4e..b17d55053d 100644 --- a/include/deal.II/fe/fe_update_flags.h +++ b/include/deal.II/fe/fe_update_flags.h @@ -35,8 +35,8 @@ template class FiniteElement; #endif -/*!@addtogroup feaccess */ -/*@{*/ +/** @addtogroup feaccess */ +/** @{ */ /** * The enum type given to the constructors of FEValues, FEFaceValues and @@ -623,7 +623,7 @@ namespace internal } // namespace internal -/*@}*/ +/** @} */ diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 2611e781d0..d1a94afed8 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -2485,7 +2485,7 @@ public: /// @name Access to shape function values /// /// These fields are filled by the finite element. - //@{ + /** @{ */ /** * Value of a shape function at a quadrature point on the cell, face or @@ -2674,9 +2674,9 @@ public: const unsigned int point_no, const unsigned int component) const; - //@} + /** @} */ /// @name Access to values of global finite element fields - //@{ + /** @{ */ /** * Return the values of a finite element function restricted to the current @@ -2847,9 +2847,9 @@ public: ArrayView> values, const bool quadrature_points_fastest) const; - //@} + /** @} */ /// @name Access to derivatives of global finite element fields - //@{ + /** @{ */ /** * Compute the gradients of a finite element at the quadrature points of a @@ -2952,11 +2952,11 @@ public: gradients, const bool quadrature_points_fastest = false) const; - //@} + /** @} */ /// @name Access to second derivatives /// /// Hessian matrices and Laplacians of global finite element fields - //@{ + /** @{ */ /** * Compute the tensor of second derivatives of a finite element at the @@ -3179,9 +3179,9 @@ public: std::vector> &laplacians, const bool quadrature_points_fastest = false) const; - //@} + /** @} */ /// @name Access to third derivatives of global finite element fields - //@{ + /** @{ */ /** * Compute the tensor of third derivatives of a finite element at the @@ -3288,10 +3288,10 @@ public: std::vector>> third_derivatives, const bool quadrature_points_fastest = false) const; - //@} + /** @} */ /// @name Cell degrees of freedom - //@{ + /** @{ */ /** * Return an object that can be thought of as an array containing all @@ -3387,10 +3387,10 @@ public: std_cxx20::ranges::iota_view dof_indices_ending_at(const unsigned int end_dof_index) const; - //@} + /** @} */ /// @name Geometry of the cell - //@{ + /** @{ */ /** * Return an object that can be thought of as an array containing all @@ -3645,10 +3645,10 @@ public: const std::vector> & get_normal_vectors() const; - //@} + /** @} */ /// @name Extractors Methods to extract individual components - //@{ + /** @{ */ /** * Create a view of the current FEValues object that represents a particular @@ -3696,10 +3696,10 @@ public: const FEValuesViews::Tensor<2, dim, spacedim> & operator[](const FEValuesExtractors::Tensor<2> &tensor) const; - //@} + /** @} */ /// @name Access to the raw data - //@{ + /** @{ */ /** * Constant reference to the selected mapping object. @@ -3739,7 +3739,7 @@ public: */ std::size_t memory_consumption() const; - //@} + /** @} */ /** diff --git a/include/deal.II/fe/mapping_c1.h b/include/deal.II/fe/mapping_c1.h index 22574def6f..74b674a447 100644 --- a/include/deal.II/fe/mapping_c1.h +++ b/include/deal.II/fe/mapping_c1.h @@ -23,8 +23,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mapping */ -/*@{*/ +/** + * @addtogroup mapping + * @{ + */ /** * Mapping class that uses C1 (continuously differentiable) cubic mappings of @@ -80,7 +82,7 @@ public: std::vector> & a) const override; }; -/*@}*/ +/** @} */ /* -------------- declaration of explicit specializations ------------- */ diff --git a/include/deal.II/fe/mapping_cartesian.h b/include/deal.II/fe/mapping_cartesian.h index e2838213d7..93df82c2fe 100644 --- a/include/deal.II/fe/mapping_cartesian.h +++ b/include/deal.II/fe/mapping_cartesian.h @@ -28,8 +28,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mapping */ -/*@{*/ +/** + * @addtogroup mapping + * @{ + */ /** * A class providing a mapping from the reference cell to cells that are @@ -415,7 +417,7 @@ private: &output_data) const; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/mapping_fe.h b/include/deal.II/fe/mapping_fe.h index 529d75e548..3941a098bc 100644 --- a/include/deal.II/fe/mapping_fe.h +++ b/include/deal.II/fe/mapping_fe.h @@ -34,9 +34,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mapping */ -/*@{*/ - +/** + * @addtogroup mapping + * @{ + */ /** * This class consistently uses a user-provided finite element on all cells of a @@ -477,7 +478,7 @@ private: -/*@}*/ +/** @} */ /*----------------------------------------------------------------------*/ diff --git a/include/deal.II/fe/mapping_fe_field.h b/include/deal.II/fe/mapping_fe_field.h index 1db832688e..4bf581d982 100644 --- a/include/deal.II/fe/mapping_fe_field.h +++ b/include/deal.II/fe/mapping_fe_field.h @@ -36,8 +36,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mapping */ -/*@{*/ +/** + * @addtogroup mapping + * @{ + */ /** * The MappingFEField is a generalization of the MappingQEulerian class, for @@ -666,7 +668,7 @@ private: friend class MappingFEField; }; -/*@}*/ +/** @} */ /* -------------- declaration of explicit specializations ------------- */ diff --git a/include/deal.II/fe/mapping_manifold.h b/include/deal.II/fe/mapping_manifold.h index 7639eee65b..0ac895c6c3 100644 --- a/include/deal.II/fe/mapping_manifold.h +++ b/include/deal.II/fe/mapping_manifold.h @@ -29,9 +29,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mapping */ -/*@{*/ - +/** + * @addtogroup mapping + * @{ + */ /** * This class implements the functionality for Manifold conforming @@ -385,7 +386,7 @@ private: -/*@}*/ +/** @} */ /*----------------------------------------------------------------------*/ diff --git a/include/deal.II/fe/mapping_q.h b/include/deal.II/fe/mapping_q.h index 801554d618..ec5750303d 100644 --- a/include/deal.II/fe/mapping_q.h +++ b/include/deal.II/fe/mapping_q.h @@ -42,9 +42,10 @@ template class MappingQCache; #endif -/*!@addtogroup mapping */ -/*@{*/ - +/** + * @addtogroup mapping + * @{ + */ /** * This class implements the functionality for polynomial mappings $Q_p$ of @@ -794,7 +795,7 @@ protected: template using MappingQGeneric = MappingQ; -/*@}*/ +/** @} */ /*----------------------------------------------------------------------*/ diff --git a/include/deal.II/fe/mapping_q1.h b/include/deal.II/fe/mapping_q1.h index cccdec4f27..b9b86451b0 100644 --- a/include/deal.II/fe/mapping_q1.h +++ b/include/deal.II/fe/mapping_q1.h @@ -25,9 +25,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mapping */ -/*@{*/ - +/** + * @addtogroup mapping + * @{ + */ /** * Implementation of a $d$-linear mapping from the reference cell to a general @@ -98,7 +99,7 @@ struct StaticMappingQ1 }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/mapping_q1_eulerian.h b/include/deal.II/fe/mapping_q1_eulerian.h index 0aeb7a862c..fab46969a1 100644 --- a/include/deal.II/fe/mapping_q1_eulerian.h +++ b/include/deal.II/fe/mapping_q1_eulerian.h @@ -32,8 +32,10 @@ template class Vector; -/*!@addtogroup mapping */ -/*@{*/ +/** + * @addtogroup mapping + * @{ + */ /** * This class provides a mapping that adds to the location of each cell @@ -186,7 +188,7 @@ protected: shiftmap_dof_handler; }; -/*@}*/ +/** @} */ /*----------------------------------------------------------------------*/ diff --git a/include/deal.II/fe/mapping_q_cache.h b/include/deal.II/fe/mapping_q_cache.h index 96cb198820..734e5d982f 100644 --- a/include/deal.II/fe/mapping_q_cache.h +++ b/include/deal.II/fe/mapping_q_cache.h @@ -36,9 +36,10 @@ class DoFHandler; #endif -/*!@addtogroup mapping */ -/*@{*/ - +/** + * @addtogroup mapping + * @{ + */ /** * This class implements a caching strategy for objects of the MappingQ family @@ -248,7 +249,7 @@ private: bool uses_level_info; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/fe/mapping_q_eulerian.h b/include/deal.II/fe/mapping_q_eulerian.h index dc34260652..e5802040c4 100644 --- a/include/deal.II/fe/mapping_q_eulerian.h +++ b/include/deal.II/fe/mapping_q_eulerian.h @@ -37,8 +37,10 @@ template class Vector; -/*!@addtogroup mapping */ -/*@{*/ +/** + * @addtogroup mapping + * @{ + */ /** * This class is an extension of the MappingQ1Eulerian class to higher order @@ -223,7 +225,7 @@ private: mutable Threads::Mutex fe_values_mutex; }; -/*@}*/ +/** @} */ /*----------------------------------------------------------------------*/ diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 73865b5f29..59bc5a25d9 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -62,7 +62,7 @@ namespace GridGenerator /** * @name Creating meshes for basic geometries */ - ///@{ + //** @{ */ /** * Initialize the given triangulation with a hypercube (line in 1D, square @@ -1827,12 +1827,12 @@ namespace GridGenerator Triangulation<3> & vol_tria, const CGALWrappers::AdditionalData<3> &data = CGALWrappers::AdditionalData<3>{}); - ///@} + //** @} */ /** * @name Creating meshes from other meshes */ - ///@{ + //** @{ */ /** * Given the two triangulations specified as the first two arguments, create @@ -2513,14 +2513,14 @@ namespace GridGenerator const double p2 = 1.0, const bool colorize = false); - ///@} + //** @} */ /** * @name Creating lower-dimensional meshes * * Created from parts of higher-dimensional meshes. */ - ///@{ + //** @{ */ #ifdef _MSC_VER // Microsoft's VC++ has a bug where it doesn't want to recognize that @@ -2648,13 +2648,13 @@ namespace GridGenerator const std::set &boundary_ids = std::set()); - ///@} + //** @} */ /** * @name Exceptions */ - ///@{ + //** @{ */ /** @@ -2681,7 +2681,7 @@ namespace GridGenerator DeclExceptionMsg(ExcInvalidInputOrientation, "The input to this function is oriented in a way that will" " cause all cells to have negative measure."); - ///@} + //** @} */ #ifndef DOXYGEN // These functions are only implemented with specializations; declare them diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 5a0d816229..73e2990570 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -131,7 +131,7 @@ namespace GridTools /** * @name Information about meshes and cells */ - /*@{*/ + /** @{ */ /** * Return the diameter of a triangulation. The diameter is computed using @@ -396,11 +396,11 @@ namespace GridTools tuple>, std::vector>, SubCellData> get_coarse_mesh_description(const Triangulation &tria); - /*@}*/ + /** @} */ /** * @name Functions supporting the creation of meshes */ - /*@{*/ + /** @{ */ /** * Remove vertices that are not referenced by any of the cells. This @@ -503,11 +503,11 @@ namespace GridTools void consistently_order_cells(std::vector> &cells); - /*@}*/ + /** @} */ /** * @name Rotating, stretching and otherwise transforming meshes */ - /*@{*/ + /** @{ */ /** * Transform the vertices of the given triangulation by applying the @@ -911,11 +911,11 @@ namespace GridTools regularize_corner_cells(Triangulation &tria, const double limit_angle_fraction = .75); - /*@}*/ + /** @} */ /** * @name Finding cells and vertices of a triangulation */ - /*@{*/ + /** @{ */ /** * Given a Triangulation's @p cache and a list of @p points, call @@ -2128,11 +2128,11 @@ namespace GridTools get_longest_direction( typename Triangulation::active_cell_iterator cell); - /*@}*/ + /** @} */ /** * @name Partitions and subdomains of triangulations */ - /*@{*/ + /** @{ */ /** * Produce a sparsity pattern in which nonzero entries indicate that two @@ -2409,11 +2409,11 @@ namespace GridTools std::vector get_locally_owned_vertices(const Triangulation &triangulation); - /*@}*/ + /** @} */ /** * @name Comparing different meshes */ - /*@{*/ + /** @{ */ /** * Given two meshes (i.e. objects of type Triangulation or DoFHandler) that @@ -2480,11 +2480,11 @@ namespace GridTools bool have_same_coarse_mesh(const MeshType &mesh_1, const MeshType &mesh_2); - /*@}*/ + /** @} */ /** * @name Dealing with distorted cells */ - /*@{*/ + /** @{ */ /** * Given a triangulation and a list of cells whose children have become @@ -2510,14 +2510,14 @@ namespace GridTools - /*@}*/ + /** @} */ /** * @name Extracting and creating patches of cells * * These functions extract and create patches of cells surrounding a single * cell, and creating triangulation out of them. */ - /*@{*/ + /** @{ */ /** @@ -2703,12 +2703,12 @@ namespace GridTools get_dof_to_support_patch_map(DoFHandler &dof_handler); - /*@}*/ + /** @} */ /** * @name Dealing with periodic domains */ - /*@{*/ + /** @{ */ /** * Data type that provides all information necessary to create periodicity @@ -2945,11 +2945,11 @@ namespace GridTools dealii::Tensor<1, MeshType::space_dimension>(), const FullMatrix &matrix = FullMatrix()); - /*@}*/ + /** @} */ /** * @name Dealing with boundary and manifold ids */ - /*@{*/ + /** @{ */ /** * Copy boundary ids to manifold ids on faces and edges at the boundary. The @@ -3076,7 +3076,7 @@ namespace GridTools return numbers::flat_manifold_id; }, bool overwrite_only_flat_manifold_ids = true); - /*@}*/ + /** @} */ /** * Exchange arbitrary data of type @p DataType provided by the function @@ -3511,7 +3511,7 @@ namespace GridTools /** * @name Exceptions */ - /*@{*/ + /** @{ */ /** * Exception @@ -3548,7 +3548,7 @@ namespace GridTools << "The given vertex with index " << arg1 << " is not used in the given triangulation."); - /*@}*/ + /** @} */ } /*namespace GridTools*/ diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index bfed183f29..2424c7fd1b 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -319,7 +319,7 @@ public: /** * @name Dereferencing */ - /*@{*/ + /** @{ */ /** * Dereferencing operator, returns a reference to an accessor. Usage is thus * like (*i).index (); @@ -369,7 +369,7 @@ public: const Accessor & access_any() const; - /*@}*/ + /** @} */ /** * Assignment operator. @@ -428,7 +428,7 @@ public: /** * @name Advancement of iterators */ - /*@{*/ + /** @{ */ /** * Prefix ++ operator: ++iterator. This operator advances * the iterator to the next element and returns a reference to @@ -468,7 +468,7 @@ public: */ TriaRawIterator operator--(int); - /*@}*/ + /** @} */ /** * Return the state of the iterator. @@ -506,7 +506,7 @@ public: /** * @name Exceptions */ - /*@{*/ + /** @{ */ /** * Exception for TriaObjects with level, i.e. cells. */ @@ -545,7 +545,7 @@ public: */ DeclException0(ExcInvalidComparison); - /*@}*/ + /** @} */ protected: /** * Object holding the real data. @@ -694,7 +694,7 @@ public: /** * @name Advancement of iterators */ - /*@{*/ + /** @{ */ /** * Prefix ++ operator: ++i. This operator advances the * iterator to the next used element and returns a reference to @@ -727,7 +727,7 @@ public: */ TriaIterator operator--(int); - /*@}*/ + /** @} */ /** * Declare some aliases which are standard for iterators and are used @@ -903,7 +903,7 @@ public: /** * @name Advancement of iterators */ - /*@{*/ + /** @{ */ /** * Postfix ++ operator: i++. This operator advances the * iterator to the next active element, but returns an iterator to the @@ -928,7 +928,7 @@ public: */ TriaActiveIterator operator--(int); - /*@}*/ + /** @} */ /** * Declare some alias which are standard for iterators and are used diff --git a/include/deal.II/lac/block_indices.h b/include/deal.II/lac/block_indices.h index 69d21b88c0..8444237e82 100644 --- a/include/deal.II/lac/block_indices.h +++ b/include/deal.II/lac/block_indices.h @@ -119,7 +119,7 @@ public: /** * @name Size information */ - //@{ + /** @{ */ /** * Number of blocks in index field. @@ -148,7 +148,7 @@ public: std::string to_string() const; - //@} + /** @} */ /** * @name Index conversion @@ -158,7 +158,7 @@ public: * object. If applied to other objects, the numbers obtained from these * functions are meaningless. */ - //@{ + /** @{ */ /** * Return the block and the index within that block for the global index @p @@ -179,7 +179,7 @@ public: */ size_type block_start(const unsigned int i) const; - //@} + /** @} */ /** * Copy operator. diff --git a/include/deal.II/lac/block_linear_operator.h b/include/deal.II/lac/block_linear_operator.h index dd1df14543..7ffdbea54a 100644 --- a/include/deal.II/lac/block_linear_operator.h +++ b/include/deal.II/lac/block_linear_operator.h @@ -564,7 +564,7 @@ namespace internal /** * @name Creation of a BlockLinearOperator */ -//@{ +/** @{ */ /** * @relatesalso BlockLinearOperator @@ -827,11 +827,11 @@ block_diagonal_operator( -//@} +/** @} */ /** * @name Manipulation of a BlockLinearOperator */ -//@{ +/** @{ */ /** * @relatesalso LinearOperator @@ -1068,7 +1068,7 @@ block_back_substitution( return return_op; } -//@} +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index 0493c86160..a478a68f3b 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -44,8 +44,9 @@ class MatrixIterator; #endif -/*! @addtogroup Matrix1 - *@{ +/** + * @addtogroup Matrix1 + * @{ */ /** @@ -823,7 +824,7 @@ public: int, << "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing column numbers."); - //@} + /** @} */ protected: /** * Release all memory and return to a state just like after having called @@ -1073,7 +1074,7 @@ private: }; -/*@}*/ +/** @} */ #ifndef DOXYGEN /* ------------------------- Template functions ---------------------- */ diff --git a/include/deal.II/lac/block_sparse_matrix.h b/include/deal.II/lac/block_sparse_matrix.h index 2eca7cb924..c018c460b5 100644 --- a/include/deal.II/lac/block_sparse_matrix.h +++ b/include/deal.II/lac/block_sparse_matrix.h @@ -30,8 +30,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Matrix1 - *@{ +/** + * @addtogroup Matrix1 + * @{ */ @@ -74,7 +75,7 @@ public: /** * @name Constructors and initialization */ - //@{ + /** @{ */ /** * Constructor; initializes the matrix to be empty, without any structure, * i.e. the matrix is not usable at all. This constructor is therefore only @@ -154,12 +155,12 @@ public: */ virtual void reinit(const BlockSparsityPattern &sparsity); - //@} + /** @} */ /** * @name Information on the matrix */ - //@{ + /** @{ */ /** * Return whether the object is empty. It is empty if either both dimensions * are zero or no BlockSparsityPattern is associated. @@ -206,12 +207,12 @@ public: */ std::size_t memory_consumption() const; - //@} + /** @} */ /** * @name Multiplications */ - //@{ + /** @{ */ /** * Matrix-vector multiplication: let $dst = M*src$ with $M$ being this * matrix. @@ -283,12 +284,12 @@ public: void Tvmult(Vector & dst, const Vector &src) const; - //@} + /** @} */ /** * @name Preconditioning methods */ - //@{ + /** @{ */ /** * Apply the Jacobi preconditioner, which multiplies every element of the * src vector by the inverse of the respective diagonal element and @@ -312,12 +313,12 @@ public: precondition_Jacobi(Vector & dst, const Vector &src, const number omega = 1.) const; - //@} + /** @} */ /** * @name Input/Output */ - //@{ + /** @{ */ /** * Print the matrix in the usual format, i.e. as a matrix and not as a list * of nonzero elements. For better readability, elements not in the matrix @@ -345,7 +346,7 @@ public: const unsigned int width = 0, const char * zero_string = " ", const double denominator = 1.) const; - //@} + /** @} */ /** * @addtogroup Exceptions * @{ @@ -355,7 +356,7 @@ public: * Exception */ DeclException0(ExcBlockDimensionMismatch); - //@} + /** @} */ private: /** @@ -369,7 +370,7 @@ private: -/*@}*/ +/** @} */ /* ------------------------- Template functions ---------------------- */ diff --git a/include/deal.II/lac/block_sparse_matrix_ez.h b/include/deal.II/lac/block_sparse_matrix_ez.h index 761297cb3f..64cdce6ecb 100644 --- a/include/deal.II/lac/block_sparse_matrix_ez.h +++ b/include/deal.II/lac/block_sparse_matrix_ez.h @@ -40,8 +40,9 @@ template class BlockVector; #endif -/*! @addtogroup Matrix1 - *@{ +/** + * @addtogroup Matrix1 + * @{ */ @@ -263,7 +264,7 @@ private: Table<2, SparseMatrixEZ> blocks; }; -/*@}*/ +/** @} */ /*----------------------------------------------------------------------*/ diff --git a/include/deal.II/lac/block_sparsity_pattern.h b/include/deal.II/lac/block_sparsity_pattern.h index d613c5a440..a801c04e0a 100644 --- a/include/deal.II/lac/block_sparsity_pattern.h +++ b/include/deal.II/lac/block_sparsity_pattern.h @@ -38,8 +38,9 @@ class BlockSparseMatrix; class BlockDynamicSparsityPattern; #endif -/*! @addtogroup Sparsity - *@{ +/** + * @addtogroup Sparsity + * @{ */ @@ -340,7 +341,7 @@ public: int, << "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing column numbers."); - //@} + /** @} */ protected: /** @@ -607,7 +608,7 @@ public: using BlockSparsityPatternBase::reinit; }; -/*@}*/ +/** @} */ #ifdef DEAL_II_WITH_TRILINOS @@ -615,8 +616,9 @@ public: namespace TrilinosWrappers { - /*! @addtogroup TrilinosWrappers - *@{ + /** + * @addtogroup TrilinosWrappers + * @{ */ /** @@ -741,7 +743,7 @@ namespace TrilinosWrappers using BlockSparsityPatternBase::reinit; }; - /*@}*/ + /** @} */ } /* namespace TrilinosWrappers */ diff --git a/include/deal.II/lac/block_vector.h b/include/deal.II/lac/block_vector.h index 9ed2a22492..3a55071a3a 100644 --- a/include/deal.II/lac/block_vector.h +++ b/include/deal.II/lac/block_vector.h @@ -46,8 +46,9 @@ namespace TrilinosWrappers #endif -/*! @addtogroup Vectors - *@{ +/** + * @addtogroup Vectors + * @{ */ @@ -364,10 +365,10 @@ public: * Exception */ DeclException0(ExcIteratorRangeDoesNotMatchVectorSize); - //@} + /** @} */ }; -/*@}*/ +/** @} */ #ifndef DOXYGEN /*----------------------- Inline functions ----------------------------------*/ diff --git a/include/deal.II/lac/block_vector_base.h b/include/deal.II/lac/block_vector_base.h index 51cfe5765f..636babfe39 100644 --- a/include/deal.II/lac/block_vector_base.h +++ b/include/deal.II/lac/block_vector_base.h @@ -38,8 +38,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Vectors - *@{ +/** + * @addtogroup Vectors + * @{ */ namespace internal @@ -342,7 +343,7 @@ namespace internal "different block vectors. There is no reasonable way " "to do this."); - //@} + /** @} */ private: /** * Pointer to the block vector object to which this iterator points. @@ -964,7 +965,7 @@ protected: }; -/*@}*/ +/** @} */ /*----------------------- Inline functions ----------------------------------*/ diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index c517beae89..ff74a410e3 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -40,8 +40,9 @@ template class FullMatrix; # endif -/*! @addtogroup Matrix1 - *@{ +/** + * @addtogroup Matrix1 + * @{ */ /** @@ -502,7 +503,7 @@ public: /** * @name Constructors and initialization. */ - //@{ + /** @{ */ /** * Constructor; initializes the matrix to be empty, without any structure, * i.e. the matrix is not usable at all. This constructor is therefore only @@ -611,11 +612,11 @@ public: */ virtual void clear(); - //@} + /** @} */ /** * @name Information on the matrix */ - //@{ + /** @{ */ /** * Return whether the object is empty. It is empty if either both dimensions * are zero or no ChunkSparsityPattern is associated. @@ -673,11 +674,11 @@ public: std::size_t memory_consumption() const; - //@} + /** @} */ /** * @name Modifying entries */ - //@{ + /** @{ */ /** * Set the element (i,j) to value. Throws an error if the * entry does not exist or if value is not a finite number. Still, @@ -804,11 +805,11 @@ public: void add(const number factor, const ChunkSparseMatrix &matrix); - //@} + /** @} */ /** * @name Entry Access */ - //@{ + /** @{ */ /** * Return the value of the entry (i,j). This may be an expensive @@ -869,11 +870,11 @@ public: size_type * column_indices, number * values) const; - //@} + /** @} */ /** * @name Matrix vector multiplications */ - //@{ + /** @{ */ /** * Matrix-vector multiplication: let dst = M*src with M being * this matrix. @@ -987,11 +988,11 @@ public: const Vector &x, const Vector &b) const; - //@} + /** @} */ /** * @name Matrix norms */ - //@{ + /** @{ */ /** * Return the l1-norm of the matrix, that is $|M|_1=max_{all columns @@ -1019,11 +1020,11 @@ public: */ real_type frobenius_norm() const; - //@} + /** @} */ /** * @name Preconditioning methods */ - //@{ + /** @{ */ /** * Apply the Jacobi preconditioner, which multiplies every element of the @@ -1151,11 +1152,11 @@ public: SSOR_step(Vector & v, const Vector &b, const number om = 1.) const; - //@} + /** @} */ /** * @name Iterators */ - //@{ + /** @{ */ /** * Iterator starting at first entry of the matrix. This is the version for @@ -1270,11 +1271,11 @@ public: */ iterator end(const unsigned int r); - //@} + /** @} */ /** * @name Input/Output */ - //@{ + /** @{ */ /** * Print the matrix to the given stream, using the format (line,col) @@ -1350,7 +1351,7 @@ public: */ void block_read(std::istream &in); - //@} + /** @} */ /** * @addtogroup Exceptions * @{ @@ -1397,7 +1398,7 @@ public: "You are attempting an operation on two matrices that " "are the same object, but the operation requires that the " "two objects are in fact different."); - //@} + /** @} */ private: /** * Pointer to the sparsity pattern used for this matrix. In order to @@ -1440,7 +1441,7 @@ private: friend class ChunkSparseMatrixIterators::Accessor; }; -/*@}*/ +/** @} */ # ifndef DOXYGEN /*---------------------- Inline functions -----------------------------------*/ diff --git a/include/deal.II/lac/chunk_sparsity_pattern.h b/include/deal.II/lac/chunk_sparsity_pattern.h index cf93766b8f..3a45a7b3b1 100644 --- a/include/deal.II/lac/chunk_sparsity_pattern.h +++ b/include/deal.II/lac/chunk_sparsity_pattern.h @@ -36,8 +36,9 @@ template class ChunkSparseMatrix; #endif -/*! @addtogroup Sparsity - *@{ +/** + * @addtogroup Sparsity + * @{ */ @@ -826,7 +827,7 @@ public: size_type, << "The array has size " << arg1 << " but should have size " << arg2); - //@} + /** @} */ private: /** * Number of rows that this sparsity structure shall represent. @@ -858,7 +859,7 @@ private: }; -/*@}*/ +/** @} */ /*---------------------- Inline functions -----------------------------------*/ #ifndef DOXYGEN diff --git a/include/deal.II/lac/constrained_linear_operator.h b/include/deal.II/lac/constrained_linear_operator.h index 6013cec72d..f8beaf9c05 100644 --- a/include/deal.II/lac/constrained_linear_operator.h +++ b/include/deal.II/lac/constrained_linear_operator.h @@ -29,7 +29,7 @@ DEAL_II_NAMESPACE_OPEN /** * @name Indirectly applying constraints to LinearOperator */ -//@{ +/** @{ */ /** @@ -318,7 +318,7 @@ constrained_right_hand_side( return return_comp; } -//@} +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/lac/cuda_sparse_matrix.h b/include/deal.II/lac/cuda_sparse_matrix.h index ff7c325eae..98e7ae00b5 100644 --- a/include/deal.II/lac/cuda_sparse_matrix.h +++ b/include/deal.II/lac/cuda_sparse_matrix.h @@ -67,7 +67,7 @@ namespace CUDAWrappers /** * @name Constructors and initialization */ - //@{ + /** @{ */ /** * Constructor. Initialize the matrix to be empty, without any structure, * i.e., the matrix is not usable at all. This constructor is therefore @@ -121,12 +121,12 @@ namespace CUDAWrappers void reinit(Utilities::CUDA::Handle & handle, const ::dealii::SparseMatrix &sparse_matrix_host); - //@} + /** @} */ /** * @name Information on the matrix */ - //@{ + /** @{ */ /** * Return the dimension of the codomain (or range) space. Note that the * matrix is of dimension $m \times n$. @@ -192,12 +192,12 @@ namespace CUDAWrappers const unsigned int width = 0, const char * zero_string = " ", const double denominator = 1.) const; - //@} + /** @} */ /** * @name Modifying entries */ - //@{ + /** @{ */ /** * Multiply the entire matrix by a fixed factor. */ @@ -209,12 +209,12 @@ namespace CUDAWrappers */ SparseMatrix & operator/=(const Number factor); - //@} + /** @} */ /** * @name Multiplications */ - //@{ + /** @{ */ /** * Matrix-vector multiplication: let $dst = M \cdot src$ with $M$ * being this matrix. @@ -281,12 +281,12 @@ namespace CUDAWrappers residual(LinearAlgebra::CUDAWrappers::Vector & dst, const LinearAlgebra::CUDAWrappers::Vector &x, const LinearAlgebra::CUDAWrappers::Vector &b) const; - //@} + /** @} */ /** * @name Matrix norms */ - //@{ + /** @{ */ /** * Return the $l_1$-norm of the matrix, that is $|M|_1=\max_{\mathrm{all\ * columns\ }j}\sum_{\mathrm{all\ rows\ }i} |M_{ij}|$, (max. sum of @@ -312,12 +312,12 @@ namespace CUDAWrappers */ Number frobenius_norm() const; - //@} + /** @} */ /** * @name Access to underlying CUDA data */ - //@{ + /** @{ */ /** * Return a tuple containing the pointer to the values of matrix, the * pointer to the columns indices, the pointer to the rows pointer, @@ -325,7 +325,7 @@ namespace CUDAWrappers */ std::tuple get_cusparse_matrix() const; - //@} + /** @} */ private: /** diff --git a/include/deal.II/lac/dynamic_sparsity_pattern.h b/include/deal.II/lac/dynamic_sparsity_pattern.h index 1269af6805..031e48f8e2 100644 --- a/include/deal.II/lac/dynamic_sparsity_pattern.h +++ b/include/deal.II/lac/dynamic_sparsity_pattern.h @@ -36,8 +36,9 @@ DEAL_II_NAMESPACE_OPEN class DynamicSparsityPattern; #endif -/*! @addtogroup Sparsity - *@{ +/** + * @addtogroup Sparsity + * @{ */ @@ -736,7 +737,7 @@ private: friend class DynamicSparsityPatternIterators::Accessor; }; -/*@}*/ +/** @} */ /*---------------------- Inline functions -----------------------------------*/ diff --git a/include/deal.II/lac/eigen.h b/include/deal.II/lac/eigen.h index 672f995f57..c7775f1592 100644 --- a/include/deal.II/lac/eigen.h +++ b/include/deal.II/lac/eigen.h @@ -33,8 +33,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ /** * Power method (von Mises) for eigenvalue computations. @@ -186,7 +188,7 @@ protected: AdditionalData additional_data; }; -/*@}*/ +/** @} */ //--------------------------------------------------------------------------- diff --git a/include/deal.II/lac/exceptions.h b/include/deal.II/lac/exceptions.h index c1f89f4184..cb66b3d3a3 100644 --- a/include/deal.II/lac/exceptions.h +++ b/include/deal.II/lac/exceptions.h @@ -27,7 +27,7 @@ namespace LACExceptions /** * @addtogroup Exceptions */ - //@{ + /** @{ */ /** * This function only works for quadratic matrices. @@ -83,7 +83,7 @@ namespace LACExceptions << "An error with error number " << arg1 << " occurred while calling a Trilinos function"); - //@} + /** @} */ } // namespace LACExceptions diff --git a/include/deal.II/lac/full_matrix.h b/include/deal.II/lac/full_matrix.h index 2d8357228c..be214bdfec 100644 --- a/include/deal.II/lac/full_matrix.h +++ b/include/deal.II/lac/full_matrix.h @@ -43,8 +43,9 @@ template class LAPACKFullMatrix; #endif -/*! @addtogroup Matrix1 - *@{ +/** + * @addtogroup Matrix1 + * @{ */ @@ -130,7 +131,7 @@ public: /** * @name Constructors and initialization. See also the base class Table. */ - //@{ + /** @{ */ /** * Constructor. Initialize the matrix as a square matrix with dimension @@ -528,9 +529,9 @@ public: std::size_t memory_consumption() const; - //@} + /** @} */ ///@name Iterator functions - //@{ + /** @{ */ /** * Mutable iterator starting at the first entry of row r. @@ -556,9 +557,9 @@ public: const_iterator end(const size_type r) const; - //@} + /** @} */ ///@name Modifying operators - //@{ + /** @{ */ /** * Scale the entire matrix by a fixed factor. @@ -843,9 +844,9 @@ public: void right_invert(const FullMatrix &M); - //@} + /** @} */ ///@name Multiplications - //@{ + /** @{ */ /** * Matrix-matrix-multiplication. @@ -1066,7 +1067,7 @@ public: void backward(Vector &dst, const Vector &src) const; - //@} + /** @} */ /** * @addtogroup Exceptions @@ -1107,7 +1108,7 @@ public: * Exception */ DeclException0(ExcMatrixNotPositiveDefinite); - //@} + /** @} */ }; /**@}*/ diff --git a/include/deal.II/lac/householder.h b/include/deal.II/lac/householder.h index 28da6232f3..f063f56292 100644 --- a/include/deal.II/lac/householder.h +++ b/include/deal.II/lac/householder.h @@ -34,8 +34,9 @@ template class Vector; #endif -/*! @addtogroup Matrix2 - *@{ +/** + * @addtogroup Matrix2 + * @{ */ @@ -156,7 +157,7 @@ private: FullMatrix storage; }; -/*@}*/ +/** @} */ #ifndef DOXYGEN /*-------------------------Inline functions -------------------------------*/ diff --git a/include/deal.II/lac/identity_matrix.h b/include/deal.II/lac/identity_matrix.h index 80e588e2d1..6b4fbd628d 100644 --- a/include/deal.II/lac/identity_matrix.h +++ b/include/deal.II/lac/identity_matrix.h @@ -23,8 +23,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Matrix1 - *@{ +/** + * @addtogroup Matrix1 + * @{ */ diff --git a/include/deal.II/lac/la_parallel_block_vector.h b/include/deal.II/lac/la_parallel_block_vector.h index 33970cfedf..2f1b00e851 100644 --- a/include/deal.II/lac/la_parallel_block_vector.h +++ b/include/deal.II/lac/la_parallel_block_vector.h @@ -60,8 +60,9 @@ namespace LinearAlgebra { namespace distributed { - /*! @addtogroup Vectors - *@{ + /** + * @addtogroup Vectors + * @{ */ @@ -125,7 +126,7 @@ namespace LinearAlgebra /** * @name 1: Basic operations */ - //@{ + /** @{ */ /** * Constructor. There are three ways to use this constructor. First, @@ -446,12 +447,12 @@ namespace LinearAlgebra */ void swap(BlockVector &v); - //@} + /** @} */ /** * @name 2: Implementation of VectorSpaceVector */ - //@{ + /** @{ */ /** * Change the dimension to that of the vector V. The elements of V are not @@ -704,7 +705,7 @@ namespace LinearAlgebra */ virtual std::size_t memory_consumption() const override; - //@} + /** @} */ /** * @addtogroup Exceptions @@ -722,10 +723,10 @@ namespace LinearAlgebra * Exception */ DeclException0(ExcIteratorRangeDoesNotMatchVectorSize); - //@} + /** @} */ }; - /*@}*/ + /** @} */ } // end of namespace distributed diff --git a/include/deal.II/lac/la_parallel_vector.h b/include/deal.II/lac/la_parallel_vector.h index a2bdced59a..adbd4f5ae0 100644 --- a/include/deal.II/lac/la_parallel_vector.h +++ b/include/deal.II/lac/la_parallel_vector.h @@ -79,8 +79,9 @@ namespace LinearAlgebra { namespace distributed { - /*! @addtogroup Vectors - *@{ + /** + * @addtogroup Vectors + * @{ */ /** @@ -271,7 +272,7 @@ namespace LinearAlgebra /** * @name 1: Basic Object-handling */ - //@{ + /** @{ */ /** * Empty constructor. */ @@ -474,12 +475,12 @@ namespace LinearAlgebra Vector & operator=(const Vector &in_vector); - //@} + /** @} */ /** * @name 2: Parallel data exchange */ - //@{ + /** @{ */ /** * This function copies the data that has accumulated in the data buffer * for ghost indices to the owning processor. For the meaning of the @@ -688,12 +689,12 @@ namespace LinearAlgebra import(const Vector &src, VectorOperation::values operation); - //@} + /** @} */ /** * @name 3: Implementation of VectorSpaceVector */ - //@{ + /** @{ */ /** * Change the dimension to that of the vector V. The elements of V are not @@ -889,12 +890,12 @@ namespace LinearAlgebra */ virtual std::size_t memory_consumption() const override; - //@} + /** @} */ /** * @name 4: Other vector operations not included in VectorSpaceVector */ - //@{ + /** @{ */ /** * Sets all elements of the vector to the scalar @p s. If the scalar is @@ -930,13 +931,13 @@ namespace LinearAlgebra void sadd(const Number s, const Vector &V); - //@} + /** @} */ /** * @name 5: Entry access and local data representation */ - //@{ + /** @{ */ /** * Return the local size of the vector, i.e., the number of indices @@ -1153,12 +1154,12 @@ namespace LinearAlgebra */ real_type lp_norm(const real_type p) const; - //@} + /** @} */ /** * @name 6: Mixed stuff */ - //@{ + /** @{ */ /** * Return a reference to the MPI communicator object in use with this @@ -1219,7 +1220,7 @@ namespace LinearAlgebra const std::vector> & shared_vector_data() const; - //@} + /** @} */ /** * Attempt to perform an operation between two incompatible vector types. @@ -1431,7 +1432,7 @@ namespace LinearAlgebra template friend class BlockVector; }; - /*@}*/ + /** @} */ /*-------------------- Inline functions ---------------------------------*/ diff --git a/include/deal.II/lac/la_vector.h b/include/deal.II/lac/la_vector.h index 008c95734d..a865fdbaa5 100644 --- a/include/deal.II/lac/la_vector.h +++ b/include/deal.II/lac/la_vector.h @@ -62,8 +62,9 @@ DEAL_II_NAMESPACE_OPEN */ namespace LinearAlgebra { - /*! @addtogroup Vectors - *@{ + /** + * @addtogroup Vectors + * @{ */ /** @@ -421,7 +422,7 @@ namespace LinearAlgebra friend class Vector; }; - /*@}*/ + /** @} */ /*--------------------------- Inline functions ----------------------------*/ template diff --git a/include/deal.II/lac/linear_operator.h b/include/deal.II/lac/linear_operator.h index 321724d443..9bec900bbb 100644 --- a/include/deal.II/lac/linear_operator.h +++ b/include/deal.II/lac/linear_operator.h @@ -314,7 +314,7 @@ public: /** * @name In-place vector space operations */ - //@{ + /** @{ */ /** * Addition with a LinearOperator @p second_op with the same @p Domain and @@ -367,14 +367,14 @@ public: */ bool is_null_operator; - //@} + /** @} */ }; /** * @name Vector space operations */ -//@{ +/** @{ */ /** * @relatesalso LinearOperator @@ -562,13 +562,13 @@ operator*(const LinearOperator &op, return number * op; } -//@} +/** @} */ /** * @name Composition and manipulation of a LinearOperator */ -//@{ +/** @{ */ /** * @relatesalso LinearOperator @@ -840,13 +840,13 @@ inverse_operator(const LinearOperator &op, return inverse_operator(op, solver); } -//@} +/** @} */ /** * @name Creation of a LinearOperator */ -//@{ +/** @{ */ /** * @relatesalso LinearOperator @@ -1477,7 +1477,7 @@ linear_operator(const LinearOperator &operator_exemplar, } -//@} +/** @} */ #ifndef DOXYGEN diff --git a/include/deal.II/lac/packaged_operation.h b/include/deal.II/lac/packaged_operation.h index 13a86bb1d1..1226ea0934 100644 --- a/include/deal.II/lac/packaged_operation.h +++ b/include/deal.II/lac/packaged_operation.h @@ -198,7 +198,7 @@ public: /** * @name In-place vector space operations */ - //@{ + /** @{ */ /** * Addition with a PackagedOperation @p second_comp with the same @p Range. @@ -252,7 +252,7 @@ public: *this = *this * number; return *this; } - //@} + /** @} */ /** * Store the result of the PackagedOperation in a vector v of the @p Range @@ -280,7 +280,7 @@ public: /** * @name Vector space operations */ -//@{ +/** @{ */ /** * @relatesalso PackagedOperation @@ -470,13 +470,13 @@ operator-(const Range &offset, const PackagedOperation &comp) return PackagedOperation(offset) - comp; } -//@} +/** @} */ /** * @name Creation of a PackagedOperation object */ -//@{ +/** @{ */ namespace internal { @@ -805,7 +805,7 @@ operator*(const PackagedOperation & comp, return return_comp; } -//@} +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/lac/petsc_block_sparse_matrix.h b/include/deal.II/lac/petsc_block_sparse_matrix.h index dc49dd1c21..913a694b87 100644 --- a/include/deal.II/lac/petsc_block_sparse_matrix.h +++ b/include/deal.II/lac/petsc_block_sparse_matrix.h @@ -37,8 +37,9 @@ namespace PETScWrappers { namespace MPI { - /*! @addtogroup PETScWrappers - *@{ + /** + * @addtogroup PETScWrappers + * @{ */ /** @@ -274,7 +275,7 @@ namespace PETScWrappers - /*@}*/ + /** @} */ // ------------- inline and template functions ----------------- diff --git a/include/deal.II/lac/petsc_block_vector.h b/include/deal.II/lac/petsc_block_vector.h index afebbff485..97c80245a6 100644 --- a/include/deal.II/lac/petsc_block_vector.h +++ b/include/deal.II/lac/petsc_block_vector.h @@ -37,8 +37,9 @@ namespace PETScWrappers namespace MPI { - /*! @addtogroup PETScWrappers - *@{ + /** + * @addtogroup PETScWrappers + * @{ */ /** @@ -285,7 +286,7 @@ namespace PETScWrappers DeclException0(ExcNonMatchingBlockVectors); }; - /*@}*/ + /** @} */ /*--------------------- Inline functions --------------------------------*/ diff --git a/include/deal.II/lac/petsc_full_matrix.h b/include/deal.II/lac/petsc_full_matrix.h index 5ad7fe2270..05e5d68c0f 100644 --- a/include/deal.II/lac/petsc_full_matrix.h +++ b/include/deal.II/lac/petsc_full_matrix.h @@ -30,8 +30,9 @@ DEAL_II_NAMESPACE_OPEN namespace PETScWrappers { - /*! @addtogroup PETScWrappers - *@{ + /** + * @addtogroup PETScWrappers + * @{ */ /** @@ -93,7 +94,7 @@ namespace PETScWrappers do_reinit(const size_type m, const size_type n); }; - /*@}*/ + /** @} */ } // namespace PETScWrappers diff --git a/include/deal.II/lac/petsc_sparse_matrix.h b/include/deal.II/lac/petsc_sparse_matrix.h index 152efc294c..edfeb9b3ae 100644 --- a/include/deal.II/lac/petsc_sparse_matrix.h +++ b/include/deal.II/lac/petsc_sparse_matrix.h @@ -518,7 +518,7 @@ namespace PETScWrappers << "The number of local rows " << arg1 << " must be larger than the total number of rows " << arg2); - //@} + /** @} */ /** * Return the square of the norm of the vector $v$ with respect to the diff --git a/include/deal.II/lac/petsc_vector.h b/include/deal.II/lac/petsc_vector.h index bfcfb92179..7f4e2a10c7 100644 --- a/include/deal.II/lac/petsc_vector.h +++ b/include/deal.II/lac/petsc_vector.h @@ -34,8 +34,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup PETScWrappers - *@{ +/** + * @addtogroup PETScWrappers + * @{ */ namespace PETScWrappers { diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index f52fb17246..035c86afc8 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -54,8 +54,9 @@ namespace LinearAlgebra #endif -/*! @addtogroup Preconditioners - *@{ +/** + * @addtogroup Preconditioners + * @{ */ @@ -1879,7 +1880,7 @@ private: -/*@}*/ +/** @} */ /* ---------------------------------- Inline functions ------------------- */ #ifndef DOXYGEN diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index 2ee41e9ded..ea90fa9209 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -29,8 +29,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Preconditioners - *@{ +/** + * @addtogroup Preconditioners + * @{ */ @@ -328,7 +329,7 @@ public: */ DeclException0(ExcInverseMatricesAlreadyExist); - //@} + /** @} */ protected: /** @@ -890,7 +891,7 @@ public: Tstep(Vector &dst, const Vector &rhs) const; }; -/*@}*/ +/** @} */ //--------------------------------------------------------------------------- #ifndef DOXYGEN diff --git a/include/deal.II/lac/precondition_selector.h b/include/deal.II/lac/precondition_selector.h index 06026aa17d..31849f39fd 100644 --- a/include/deal.II/lac/precondition_selector.h +++ b/include/deal.II/lac/precondition_selector.h @@ -35,8 +35,9 @@ class SparseMatrix; #endif -/*! @addtogroup Preconditioners - *@{ +/** + * @addtogroup Preconditioners + * @{ */ /** @@ -176,7 +177,7 @@ public: */ DeclException0(ExcNoMatrixGivenToUse); - //@} + /** @} */ protected: /** * Stores the name of the preconditioning. @@ -197,7 +198,7 @@ private: const typename VectorType::value_type omega; }; -/*@}*/ +/** @} */ /* --------------------- Inline and template functions ------------------- */ diff --git a/include/deal.II/lac/read_write_vector.h b/include/deal.II/lac/read_write_vector.h index 9ac4e5c311..9a915f0f5b 100644 --- a/include/deal.II/lac/read_write_vector.h +++ b/include/deal.II/lac/read_write_vector.h @@ -92,8 +92,9 @@ namespace LinearAlgebra namespace LinearAlgebra { - /*! @addtogroup Vectors - *@{ + /** + * @addtogroup Vectors + * @{ */ /** @@ -151,7 +152,7 @@ namespace LinearAlgebra /** * @name 1: Basic Object-handling */ - //@{ + /** @{ */ /** * Empty constructor. */ @@ -471,13 +472,13 @@ namespace LinearAlgebra */ const_iterator end() const; - //@} + /** @} */ /** * @name 2: Data-Access */ - //@{ + /** @{ */ /** * Read access to the data in the position corresponding to @p @@ -593,13 +594,13 @@ namespace LinearAlgebra */ Number & local_element(const size_type local_index); - //@} + /** @} */ /** * @name 3: Modification of vectors */ - //@{ + /** @{ */ /** * This function adds a whole set of values stored in @p values to the @@ -643,7 +644,7 @@ namespace LinearAlgebra */ std::size_t memory_consumption() const; - //@} + /** @} */ protected: #ifdef DEAL_II_WITH_TRILINOS @@ -781,7 +782,7 @@ namespace LinearAlgebra }; }; - /*@}*/ + /** @} */ /*---------------------------- Inline functions ---------------------------*/ diff --git a/include/deal.II/lac/schur_complement.h b/include/deal.II/lac/schur_complement.h index c3228cca84..187a11e634 100644 --- a/include/deal.II/lac/schur_complement.h +++ b/include/deal.II/lac/schur_complement.h @@ -30,7 +30,7 @@ DEAL_II_NAMESPACE_OPEN /** * @name Creation of a LinearOperator related to the Schur Complement */ -//@{ +/** @{ */ /** * @relatesalso LinearOperator @@ -261,13 +261,13 @@ schur_complement(const LinearOperator &A_inv, return -1.0 * C * A_inv * B; } -//@} +/** @} */ /** * @name Creation of PackagedOperation objects related to the Schur Complement */ -//@{ +/** @{ */ /** * @relatesalso PackagedOperation @@ -347,7 +347,7 @@ postprocess_schur_solution( return A_inv * (f - B * y); } -//@} +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/lac/solver_bicgstab.h b/include/deal.II/lac/solver_bicgstab.h index 27397bcda9..8dc901a874 100644 --- a/include/deal.II/lac/solver_bicgstab.h +++ b/include/deal.II/lac/solver_bicgstab.h @@ -30,8 +30,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ namespace internal { @@ -286,7 +288,7 @@ private: iterate(const MatrixType &A, const PreconditionerType &preconditioner); }; -/*@}*/ +/** @} */ /*-------------------------Inline functions -------------------------------*/ #ifndef DOXYGEN diff --git a/include/deal.II/lac/solver_cg.h b/include/deal.II/lac/solver_cg.h index 5aa2d1d338..63902fd915 100644 --- a/include/deal.II/lac/solver_cg.h +++ b/include/deal.II/lac/solver_cg.h @@ -46,8 +46,8 @@ namespace LinearAlgebra #endif -/*!@addtogroup Solvers */ -/*@{*/ +/** @addtogroup Solvers */ +/** @{ */ /** * This class implements the preconditioned Conjugate Gradients (CG) @@ -383,7 +383,7 @@ public: }; -/*@}*/ +/** @} */ /*------------------------- Implementation ----------------------------*/ diff --git a/include/deal.II/lac/solver_control.h b/include/deal.II/lac/solver_control.h index 2a15485ea9..45508e12d5 100644 --- a/include/deal.II/lac/solver_control.h +++ b/include/deal.II/lac/solver_control.h @@ -29,8 +29,10 @@ DEAL_II_NAMESPACE_OPEN class ParameterHandler; #endif -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ /** * Control class to determine convergence of iterative solvers. @@ -615,7 +617,7 @@ protected: unsigned int n_converged_iterations; }; -/*@}*/ +/** @} */ //--------------------------------------------------------------------------- #ifndef DOXYGEN diff --git a/include/deal.II/lac/solver_fire.h b/include/deal.II/lac/solver_fire.h index 01bda880bf..35f0f7131f 100644 --- a/include/deal.II/lac/solver_fire.h +++ b/include/deal.II/lac/solver_fire.h @@ -30,8 +30,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ /** * FIRE (Fast Inertial Relaxation Engine) for minimization of (potentially @@ -179,7 +181,7 @@ protected: const AdditionalData additional_data; }; -/*@}*/ +/** @} */ /*------------------------- Implementation ----------------------------*/ diff --git a/include/deal.II/lac/solver_gmres.h b/include/deal.II/lac/solver_gmres.h index d2eda60e63..3b4e3f19ed 100644 --- a/include/deal.II/lac/solver_gmres.h +++ b/include/deal.II/lac/solver_gmres.h @@ -37,8 +37,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ namespace internal { @@ -519,7 +521,7 @@ private: FullMatrix H1; }; -/*@}*/ +/** @} */ /* --------------------- Inline and template functions ------------------- */ diff --git a/include/deal.II/lac/solver_idr.h b/include/deal.II/lac/solver_idr.h index 1e0f963660..64bc3c6793 100644 --- a/include/deal.II/lac/solver_idr.h +++ b/include/deal.II/lac/solver_idr.h @@ -33,8 +33,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ namespace internal { @@ -180,7 +182,7 @@ private: AdditionalData additional_data; }; -/*@}*/ +/** @} */ /*------------------------- Implementation ----------------------------*/ #ifndef DOXYGEN diff --git a/include/deal.II/lac/solver_minres.h b/include/deal.II/lac/solver_minres.h index 999e2a077d..a78bfa29c9 100644 --- a/include/deal.II/lac/solver_minres.h +++ b/include/deal.II/lac/solver_minres.h @@ -30,8 +30,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ /** * Minimal residual method for symmetric matrices. @@ -113,7 +115,7 @@ public: * Exception */ DeclException0(ExcPreconditionerNotDefinite); - //@} + /** @} */ protected: /** @@ -142,7 +144,7 @@ protected: double res2; }; -/*@}*/ +/** @} */ /*------------------------- Implementation ----------------------------*/ #ifndef DOXYGEN diff --git a/include/deal.II/lac/solver_qmrs.h b/include/deal.II/lac/solver_qmrs.h index 9d5dd4aec5..6e1677c0a1 100644 --- a/include/deal.II/lac/solver_qmrs.h +++ b/include/deal.II/lac/solver_qmrs.h @@ -28,8 +28,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ /** *

Quasi-minimal method for symmetric matrices (SQMR)

@@ -232,7 +234,7 @@ private: unsigned int step; }; -/*@}*/ +/** @} */ /*------------------------- Implementation ----------------------------*/ #ifndef DOXYGEN diff --git a/include/deal.II/lac/solver_richardson.h b/include/deal.II/lac/solver_richardson.h index d65ee66f63..7edc8bc873 100644 --- a/include/deal.II/lac/solver_richardson.h +++ b/include/deal.II/lac/solver_richardson.h @@ -27,8 +27,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ /** * Implementation of the preconditioned Richardson iteration method. The @@ -154,7 +156,7 @@ protected: AdditionalData additional_data; }; -/*@}*/ +/** @} */ /*----------------- Implementation of the Richardson Method ------------------*/ #ifndef DOXYGEN diff --git a/include/deal.II/lac/solver_selector.h b/include/deal.II/lac/solver_selector.h index 36b646165b..d2f2adb423 100644 --- a/include/deal.II/lac/solver_selector.h +++ b/include/deal.II/lac/solver_selector.h @@ -34,8 +34,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup Solvers */ -/*@{*/ +/** + * @addtogroup Solvers + * @{ + */ /** * Selects a solver by changing a parameter. @@ -240,7 +242,7 @@ private: typename SolverFGMRES::AdditionalData fgmres_data; }; -/*@}*/ +/** @} */ /* --------------------- Inline and template functions ------------------- */ diff --git a/include/deal.II/lac/sparse_decomposition.h b/include/deal.II/lac/sparse_decomposition.h index 506acd30c5..6f472d60dc 100644 --- a/include/deal.II/lac/sparse_decomposition.h +++ b/include/deal.II/lac/sparse_decomposition.h @@ -24,8 +24,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Preconditioners - *@{ +/** + * @addtogroup Preconditioners + * @{ */ /** @@ -274,7 +275,7 @@ public: double, << "The strengthening parameter " << arg1 << " is not greater or equal than zero!"); - //@} + /** @} */ protected: /** * Copies the passed SparseMatrix onto this object. This object's sparsity @@ -336,7 +337,7 @@ private: SparsityPattern *own_sparsity; }; -/*@}*/ +/** @} */ //--------------------------------------------------------------------------- #ifndef DOXYGEN diff --git a/include/deal.II/lac/sparse_ilu.h b/include/deal.II/lac/sparse_ilu.h index 5d07ecbca3..485877a32c 100644 --- a/include/deal.II/lac/sparse_ilu.h +++ b/include/deal.II/lac/sparse_ilu.h @@ -26,8 +26,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Preconditioners - *@{ +/** + * @addtogroup Preconditioners + * @{ */ /** @@ -152,10 +153,10 @@ public: << ". This must stop the ILU algorithm because it means " "that the matrix for which you try to compute a " "decomposition is singular."); - //@} + /** @} */ }; -/*@}*/ +/** @} */ //--------------------------------------------------------------------------- diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index e110831ef2..f3c71bd7ff 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -576,7 +576,7 @@ public: /** * @name Constructors and initialization */ - //@{ + /** @{ */ /** * Constructor; initializes the matrix to be empty, without any structure, * i.e. the matrix is not usable at all. This constructor is therefore only @@ -712,11 +712,11 @@ public: */ virtual void clear(); - //@} + /** @} */ /** * @name Information on the matrix */ - //@{ + /** @{ */ /** * Return whether the object is empty. It is empty if either both dimensions * are zero or no SparsityPattern is associated. @@ -787,11 +787,11 @@ public: */ void compress(::dealii::VectorOperation::values); - //@} + /** @} */ /** * @name Modifying entries */ - //@{ + /** @{ */ /** * Set the element (i,j) to value. Throws an error if the * entry does not exist or if value is not a finite number. Still, @@ -1050,11 +1050,11 @@ public: void add(const number factor, const SparseMatrix &matrix); - //@} + /** @} */ /** * @name Accessing elements */ - //@{ + /** @{ */ /** * Return the value of the entry (i,j). This may be an expensive @@ -1112,11 +1112,11 @@ public: number & diag_element(const size_type i); - //@} + /** @} */ /** * @name Multiplying matrices and vectors */ - //@{ + /** @{ */ /** * Matrix-vector multiplication: let dst = M*src with M being * this matrix. @@ -1314,11 +1314,11 @@ public: const Vector & V = Vector(), const bool rebuild_sparsity_pattern = true) const; - //@} + /** @} */ /** * @name Matrix norms */ - //@{ + /** @{ */ /** * Return the $l_1$-norm of the matrix, that is $|M|_1=\max_{\mathrm{all\ @@ -1346,11 +1346,11 @@ public: */ real_type frobenius_norm() const; - //@} + /** @} */ /** * @name Preconditioning methods */ - //@{ + /** @{ */ /** * Apply the Jacobi preconditioner, which multiplies every element of the @@ -1494,11 +1494,11 @@ public: SSOR_step(Vector & v, const Vector &b, const number omega = 1.) const; - //@} + /** @} */ /** * @name Iterators */ - //@{ + /** @{ */ /** * Return an iterator pointing to the first element of the matrix. @@ -1562,11 +1562,11 @@ public: */ iterator end(const size_type r); - //@} + /** @} */ /** * @name Input/Output */ - //@{ + /** @{ */ /** * Print the matrix to the given stream, using the format (row,column) @@ -1664,7 +1664,7 @@ public: */ void block_read(std::istream &in); - //@} + /** @} */ /** * @addtogroup Exceptions * @{ @@ -1715,7 +1715,7 @@ public: "You are attempting an operation on two matrices that " "are the same object, but the operation requires that the " "two objects are in fact different."); - //@} + /** @} */ protected: /** diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h index 2a1ef600b4..f854c21fa4 100644 --- a/include/deal.II/lac/sparse_matrix_ez.h +++ b/include/deal.II/lac/sparse_matrix_ez.h @@ -296,7 +296,7 @@ public: /** * @name Constructors and initialization */ - //@{ + /** @{ */ /** * Constructor. Initializes an empty matrix of dimension zero times zero. */ @@ -364,11 +364,11 @@ public: */ void clear(); - //@} + /** @} */ /** * @name Information on the matrix */ - //@{ + /** @{ */ /** * Return whether the object is empty. It is empty if both dimensions are * zero. @@ -433,11 +433,11 @@ public: size_type & reserved, std::vector &used_by_line, const bool compute_by_line) const; - //@} + /** @} */ /** * @name Modifying entries */ - //@{ + /** @{ */ /** * Set the element (i,j) to @p value. * @@ -575,11 +575,11 @@ public: template void add(const number factor, const MatrixType &matrix); - //@} + /** @} */ /** * @name Entry Access */ - //@{ + /** @{ */ /** * Return the value of the entry (i,j). This may be an expensive operation * and you should always take care where to call this function. In order to @@ -598,11 +598,11 @@ public: */ number el(const size_type i, const size_type j) const; - //@} + /** @} */ /** * @name Multiplications */ - //@{ + /** @{ */ /** * Matrix-vector multiplication: let $dst = M*src$ with $M$ being this * matrix. @@ -636,21 +636,21 @@ public: template void Tvmult_add(Vector &dst, const Vector &src) const; - //@} + /** @} */ /** * @name Matrix norms */ - //@{ + /** @{ */ /** * Frobenius-norm of the matrix. */ number l2_norm() const; - //@} + /** @} */ /** * @name Preconditioning methods */ - //@{ + /** @{ */ /** * Apply the Jacobi preconditioner, which multiplies every element of the @p * src vector by the inverse of the respective diagonal element and @@ -706,11 +706,11 @@ public: conjugate_add(const MatrixTypeA &A, const MatrixTypeB &B, const bool transpose = false); - //@} + /** @} */ /** * @name Iterators */ - //@{ + /** @{ */ /** * Iterator starting at the first existing entry. */ @@ -736,11 +736,11 @@ public: */ const_iterator end(const size_type r) const; - //@} + /** @} */ /** * @name Input/Output */ - //@{ + /** @{ */ /** * Print the matrix to the given stream, using the format (line,col) * value, i.e. one nonzero entry of the matrix per line. @@ -796,7 +796,7 @@ public: */ void block_read(std::istream &in); - //@} + /** @} */ /** * @addtogroup Exceptions @@ -822,7 +822,7 @@ public: int, << "An entry with index (" << arg1 << ',' << arg2 << ") cannot be allocated."); - //@} + /** @} */ private: /** * Find an entry and return a const pointer. Return a zero-pointer if the diff --git a/include/deal.II/lac/sparse_mic.h b/include/deal.II/lac/sparse_mic.h index ac8bc882a8..8c3ba26fc7 100644 --- a/include/deal.II/lac/sparse_mic.h +++ b/include/deal.II/lac/sparse_mic.h @@ -23,8 +23,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Preconditioners - *@{ +/** + * @addtogroup Preconditioners + * @{ */ /** @@ -150,7 +151,7 @@ public: << "The diagonal element (" << arg1 << ',' << arg1 << ") is " << arg2 << ", but must be positive"); - //@} + /** @} */ private: /** * Values of the computed diagonal. @@ -175,7 +176,7 @@ private: get_rowsum(const size_type row) const; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/lac/sparse_vanka.h b/include/deal.II/lac/sparse_vanka.h index 6e72f8c291..74157ec9c9 100644 --- a/include/deal.II/lac/sparse_vanka.h +++ b/include/deal.II/lac/sparse_vanka.h @@ -43,8 +43,9 @@ template class SparseBlockVanka; #endif -/*! @addtogroup Preconditioners - *@{ +/** + * @addtogroup Preconditioners + * @{ */ /** @@ -544,7 +545,7 @@ private: const BlockingStrategy blocking_strategy); }; -/*@}*/ +/** @} */ /* ---------------------------------- Inline functions ------------------- */ #ifndef DOXYGEN diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index 399ec60978..65d1034084 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -62,8 +62,9 @@ namespace ChunkSparsityPatternIterators } #endif -/*! @addtogroup Sparsity - *@{ +/** + * @addtogroup Sparsity + * @{ */ namespace internals diff --git a/include/deal.II/lac/sparsity_tools.h b/include/deal.II/lac/sparsity_tools.h index e845eb5f62..cfcf74bc04 100644 --- a/include/deal.II/lac/sparsity_tools.h +++ b/include/deal.II/lac/sparsity_tools.h @@ -37,8 +37,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Sparsity - *@{ +/** + * @addtogroup Sparsity + * @{ */ /** diff --git a/include/deal.II/lac/tridiagonal_matrix.h b/include/deal.II/lac/tridiagonal_matrix.h index c7966ec514..4d03298637 100644 --- a/include/deal.II/lac/tridiagonal_matrix.h +++ b/include/deal.II/lac/tridiagonal_matrix.h @@ -33,8 +33,9 @@ template class Vector; #endif -/*! @addtogroup Matrix1 - *@{ +/** + * @addtogroup Matrix1 + * @{ */ @@ -53,7 +54,7 @@ class TridiagonalMatrix { public: ///@name Constructors - //@{ + /** @{ */ /** * Declare type for container size. */ @@ -75,10 +76,10 @@ public: reinit(size_type n, bool symmetric = false); - //@} + /** @} */ ///@name Non-modifying operators - //@{ + /** @{ */ /** * Number of rows of this matrix. Note that the matrix is an m x @@ -102,10 +103,10 @@ public: bool all_zero() const; - //@} + /** @} */ ///@name Element access - //@{ + /** @{ */ /** * Read-only access to a value. This is restricted to the case where * |i-j| <= 1. @@ -125,10 +126,10 @@ public: number & operator()(size_type i, size_type j); - //@} + /** @} */ ///@name Multiplications with vectors - //@{ + /** @{ */ /** * Matrix-vector-multiplication. Multiplies v from the right and @@ -197,10 +198,10 @@ public: number matrix_norm_square(const Vector &v) const; - //@} + /** @} */ ///@name LAPACK operations - //@{ + /** @{ */ /** * Compute the eigenvalues of the symmetric tridiagonal matrix. * @@ -214,10 +215,10 @@ public: */ number eigenvalue(const size_type i) const; - //@} + /** @} */ ///@name Miscellanea - //@{ + /** @{ */ /** * Output of the matrix in user-defined format. */ @@ -226,7 +227,7 @@ public: print(OutputStream & s, const unsigned int width = 5, const unsigned int precision = 2) const; - //@} + /** @} */ private: /** diff --git a/include/deal.II/lac/trilinos_block_sparse_matrix.h b/include/deal.II/lac/trilinos_block_sparse_matrix.h index 5890f7fa00..8bb38cbb9b 100644 --- a/include/deal.II/lac/trilinos_block_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_block_sparse_matrix.h @@ -42,8 +42,9 @@ class BlockSparseMatrix; namespace TrilinosWrappers { - /*! @addtogroup TrilinosWrappers - *@{ + /** + * @addtogroup TrilinosWrappers + * @{ */ /** @@ -347,7 +348,7 @@ namespace TrilinosWrappers int, << "The blocks [" << arg1 << ',' << arg2 << "] and [" << arg3 << ',' << arg4 << "] have differing column numbers."); - ///@} + //** @} */ private: /** @@ -401,7 +402,7 @@ namespace TrilinosWrappers - /*@}*/ + /** @} */ // ------------- inline and template functions ----------------- diff --git a/include/deal.II/lac/trilinos_linear_operator.h b/include/deal.II/lac/trilinos_linear_operator.h index d559bc37da..fd42cb50b6 100644 --- a/include/deal.II/lac/trilinos_linear_operator.h +++ b/include/deal.II/lac/trilinos_linear_operator.h @@ -51,7 +51,7 @@ namespace TrilinosWrappers /** * @name Creation of a LinearOperator */ - //@{ + /** @{ */ /** @@ -149,11 +149,11 @@ namespace TrilinosWrappers } - //@} + /** @} */ /** * @name Creation of a BlockLinearOperator */ - //@{ + /** @{ */ /** @@ -302,7 +302,7 @@ namespace TrilinosWrappers return dealii::block_diagonal_operator(ops); } - //@} + /** @} */ } // namespace TrilinosWrappers diff --git a/include/deal.II/lac/trilinos_parallel_block_vector.h b/include/deal.II/lac/trilinos_parallel_block_vector.h index 4c22ebfa56..3d32bbbd9d 100644 --- a/include/deal.II/lac/trilinos_parallel_block_vector.h +++ b/include/deal.II/lac/trilinos_parallel_block_vector.h @@ -46,8 +46,9 @@ namespace TrilinosWrappers } // namespace TrilinosWrappers # endif -/*! @addtogroup TrilinosWrappers - *@{ +/** + * @addtogroup TrilinosWrappers + * @{ */ namespace TrilinosWrappers @@ -427,7 +428,7 @@ namespace TrilinosWrappers } /* namespace TrilinosWrappers */ -/*@}*/ +/** @} */ namespace internal diff --git a/include/deal.II/lac/trilinos_precondition.h b/include/deal.II/lac/trilinos_precondition.h index 0050877869..85819e6e6b 100644 --- a/include/deal.II/lac/trilinos_precondition.h +++ b/include/deal.II/lac/trilinos_precondition.h @@ -56,8 +56,9 @@ class Vector; class SparsityPattern; # endif -/*! @addtogroup TrilinosWrappers - *@{ +/** + * @addtogroup TrilinosWrappers + * @{ */ namespace TrilinosWrappers @@ -176,7 +177,7 @@ namespace TrilinosWrappers /** * @name Access to underlying Trilinos data */ - //@{ + /** @{ */ /** * * Calling this function from an uninitialized object will cause an @@ -184,12 +185,12 @@ namespace TrilinosWrappers */ Epetra_Operator & trilinos_operator() const; - //@} + /** @} */ /** * @name Partitioners */ - //@{ + /** @{ */ /** * Return the partitioning of the domain space of this matrix, i.e., the @@ -206,12 +207,12 @@ namespace TrilinosWrappers IndexSet locally_owned_range_indices() const; - //@} + /** @} */ /** * @addtogroup Exceptions */ - //@{ + /** @{ */ /** * Exception. */ @@ -220,7 +221,7 @@ namespace TrilinosWrappers << "The sparse matrix the preconditioner is based on " << "uses a map that is not compatible to the one in vector " << arg1 << ". Check preconditioner and matrix setup."); - //@} + /** @} */ friend class SolverBase; @@ -2181,7 +2182,7 @@ namespace TrilinosWrappers } // namespace TrilinosWrappers -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index cdea737e40..3f8c6f669e 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -595,7 +595,7 @@ namespace TrilinosWrappers /** * @name Constructors and initialization. */ - //@{ + /** @{ */ /** * Default constructor. Generates an empty (zero-size) matrix. */ @@ -729,12 +729,12 @@ namespace TrilinosWrappers */ void reinit(const Epetra_CrsMatrix &input_matrix, const bool copy_values = true); - //@} + /** @} */ /** * @name Constructors and initialization using an IndexSet description */ - //@{ + /** @{ */ /** * Constructor using an IndexSet and an MPI communicator to describe the * %parallel partitioning. The parameter @p n_max_entries_per_row sets the @@ -895,11 +895,11 @@ namespace TrilinosWrappers const double drop_tolerance = 1e-13, const bool copy_values = true, const ::dealii::SparsityPattern * use_this_sparsity = nullptr); - //@} + /** @} */ /** * @name Information on the matrix */ - //@{ + /** @{ */ /** * Return the number of rows in this matrix. @@ -978,11 +978,11 @@ namespace TrilinosWrappers MPI_Comm get_mpi_communicator() const; - //@} + /** @} */ /** * @name Modifying entries */ - //@{ + /** @{ */ /** * This operator assigns a scalar to a matrix. Since this does usually not @@ -1355,11 +1355,11 @@ namespace TrilinosWrappers void transpose(); - //@} + /** @} */ /** * @name Entry Access */ - //@{ + /** @{ */ /** * Return the value of the entry (i,j). This may be an expensive @@ -1400,11 +1400,11 @@ namespace TrilinosWrappers TrilinosScalar diag_element(const size_type i) const; - //@} + /** @} */ /** * @name Multiplications */ - //@{ + /** @{ */ /** * Matrix-vector multiplication: let dst = M*src with M @@ -1617,11 +1617,11 @@ namespace TrilinosWrappers const SparseMatrix &B, const MPI::Vector & V = MPI::Vector()) const; - //@} + /** @} */ /** * @name Matrix norms */ - //@{ + /** @{ */ /** * Return the l1-norm of the matrix, that is $|M|_1= @@ -1651,11 +1651,11 @@ namespace TrilinosWrappers TrilinosScalar frobenius_norm() const; - //@} + /** @} */ /** * @name Access to underlying Trilinos data */ - //@{ + /** @{ */ /** * Return a const reference to the underlying Trilinos Epetra_CrsMatrix @@ -1671,12 +1671,12 @@ namespace TrilinosWrappers const Epetra_CrsGraph & trilinos_sparsity_pattern() const; - //@} + /** @} */ /** * @name Partitioners */ - //@{ + /** @{ */ /** * Return the partitioning of the domain space of this matrix, i.e., the @@ -1693,12 +1693,12 @@ namespace TrilinosWrappers IndexSet locally_owned_range_indices() const; - //@} + /** @} */ /** * @name Iterators */ - //@{ + /** @{ */ /** * Return an iterator pointing to the first element of the matrix. @@ -1795,11 +1795,11 @@ namespace TrilinosWrappers iterator end(const size_type r); - //@} + /** @} */ /** * @name Input/Output */ - //@{ + /** @{ */ /** * Abstract Trilinos object that helps view in ASCII other Trilinos @@ -1820,11 +1820,11 @@ namespace TrilinosWrappers print(std::ostream &out, const bool write_extended_trilinos_info = false) const; - //@} + /** @} */ /** * @addtogroup Exceptions */ - //@{ + /** @{ */ /** * Exception */ @@ -1899,7 +1899,7 @@ namespace TrilinosWrappers << "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a sparse matrix, but it appears to not" << " exist in the Trilinos sparsity pattern."); - //@} + /** @} */ @@ -2082,7 +2082,7 @@ namespace TrilinosWrappers /** * @name Constructors / destructor */ - //@{ + /** @{ */ /** * Default constructor @@ -2213,12 +2213,12 @@ namespace TrilinosWrappers TrilinosPayload> inverse_payload(Solver &, const Preconditioner &) const; - //@} + /** @} */ /** * @name LinearOperator functionality */ - //@{ + /** @{ */ /** * Return an IndexSet that defines the partitioning of the domain space @@ -2289,12 +2289,12 @@ namespace TrilinosWrappers */ std::function inv_Tvmult; - //@} + /** @} */ /** * @name Core Epetra_Operator functionality */ - //@{ + /** @{ */ /** * Return the status of the transpose flag for this operator @@ -2357,12 +2357,12 @@ namespace TrilinosWrappers */ virtual int ApplyInverse(const VectorType &Y, VectorType &X) const override; - //@} + /** @} */ /** * @name Additional Epetra_Operator functionality */ - //@{ + /** @{ */ /** * Return a label to describe this class. @@ -2403,7 +2403,7 @@ namespace TrilinosWrappers */ virtual const Epetra_Map & OperatorRangeMap() const override; - //@} + /** @} */ private: /** diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index 38ffa5097f..aa417bd35e 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -287,7 +287,7 @@ namespace TrilinosWrappers /** * @name Basic constructors and initialization */ - //@{ + /** @{ */ /** * Default constructor. Generates an empty (zero-size) sparsity pattern. */ @@ -415,12 +415,12 @@ namespace TrilinosWrappers */ void compress(); - //@} + /** @} */ /** * @name Constructors and initialization using an IndexSet description */ - //@{ + /** @{ */ /** * Constructor for a square sparsity pattern using an IndexSet and an MPI @@ -648,11 +648,11 @@ namespace TrilinosWrappers const SparsityPatternType &nontrilinos_sparsity_pattern, const MPI_Comm & communicator = MPI_COMM_WORLD, const bool exchange_data = false); - //@} + /** @} */ /** * @name Information on the sparsity pattern */ - //@{ + /** @{ */ /** * Return the state of the sparsity pattern, i.e., whether compress() @@ -763,11 +763,11 @@ namespace TrilinosWrappers std::size_t memory_consumption() const; - //@} + /** @} */ /** * @name Adding entries */ - //@{ + /** @{ */ /** * Add the element (i,j) to the sparsity pattern. */ @@ -784,11 +784,11 @@ namespace TrilinosWrappers ForwardIterator begin, ForwardIterator end, const bool indices_are_sorted = false); - //@} + /** @} */ /** * @name Access of underlying Trilinos data */ - //@{ + /** @{ */ /** * Return a const reference to the underlying Trilinos Epetra_CrsGraph @@ -820,12 +820,12 @@ namespace TrilinosWrappers */ MPI_Comm get_mpi_communicator() const; - //@} + /** @} */ /** * @name Partitioners */ - //@{ + /** @{ */ /** * Return the partitioning of the domain space of this pattern, i.e., the @@ -843,12 +843,12 @@ namespace TrilinosWrappers IndexSet locally_owned_range_indices() const; - //@} + /** @} */ /** * @name Iterators */ - //@{ + /** @{ */ /** * Iterator starting at the first entry. @@ -884,11 +884,11 @@ namespace TrilinosWrappers const_iterator end(const size_type r) const; - //@} + /** @} */ /** * @name Input/Output */ - //@{ + /** @{ */ /** * Abstract Trilinos object that helps view in ASCII other Trilinos @@ -926,7 +926,7 @@ namespace TrilinosWrappers void print_gnuplot(std::ostream &out) const; - //@} + /** @} */ /** * @addtogroup Exceptions * @{ @@ -980,7 +980,7 @@ namespace TrilinosWrappers << "You tried to access element (" << arg1 << '/' << arg2 << ')' << " of a sparse matrix, but it appears to not" << " exist in the Trilinos sparsity pattern."); - //@} + /** @} */ private: /** * Pointer to the user-supplied Epetra Trilinos mapping of the matrix diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index 7bf5c3ed4f..cd2f45619c 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -414,7 +414,7 @@ namespace TrilinosWrappers /** * @name 1: Basic Object-handling */ - //@{ + /** @{ */ /** * Default constructor that generates an empty (zero size) vector. The * function reinit() will have to give the vector the correct @@ -910,13 +910,13 @@ namespace TrilinosWrappers */ bool is_non_negative() const; - //@} + /** @} */ /** * @name 2: Data-Access */ - //@{ + /** @{ */ /** * Provide access to a given element, both read and write. @@ -1040,13 +1040,13 @@ namespace TrilinosWrappers const_iterator end() const; - //@} + /** @} */ /** * @name 3: Modification of vectors */ - //@{ + /** @{ */ /** * A collective set operation: instead of setting individual elements of a @@ -1189,12 +1189,12 @@ namespace TrilinosWrappers */ void equ(const TrilinosScalar a, const Vector &V); - //@} + /** @} */ /** * @name 4: Mixed stuff */ - //@{ + /** @{ */ /** * Return a const reference to the underlying Trilinos Epetra_MultiVector @@ -1258,7 +1258,7 @@ namespace TrilinosWrappers */ const MPI_Comm & get_mpi_communicator() const; - //@} + /** @} */ /** * Exception @@ -2209,7 +2209,7 @@ namespace TrilinosWrappers } /* end of namespace TrilinosWrappers */ -/*@}*/ +/** @} */ namespace internal diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index b031633fb1..ee7cfbb37b 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -74,8 +74,9 @@ namespace parallel #endif -/*! @addtogroup Vectors - *@{ +/** + * @addtogroup Vectors + * @{ */ /** @@ -141,7 +142,7 @@ public: /** * @name Basic object handling */ - //@{ + /** @{ */ /** * Constructor. Create a vector of dimension zero. */ @@ -451,13 +452,13 @@ public: bool operator!=(const Vector &v) const; - //@} + /** @} */ /** * @name Scalar products, norms and related operations */ - //@{ + /** @{ */ /** * Return the scalar product of two vectors. The return type is the @@ -561,13 +562,13 @@ public: Number add_and_dot(const Number a, const Vector &V, const Vector &W); - //@} + /** @} */ /** * @name Data access */ - //@{ + /** @{ */ /** * Return a pointer to the underlying data buffer. @@ -688,13 +689,13 @@ public: extract_subvector_to(ForwardIterator indices_begin, const ForwardIterator indices_end, OutputIterator values_begin) const; - //@} + /** @} */ /** * @name Modification of vectors */ - //@{ + /** @{ */ /** * Add the given vector to the present one. @@ -840,13 +841,13 @@ public: */ void update_ghost_values() const; - //@} + /** @} */ /** * @name Input and output */ - //@{ + /** @{ */ /** * Print to a stream. @p precision denotes the desired precision with which * values shall be printed, @p scientific whether scientific notation shall @@ -921,7 +922,7 @@ public: /** * @name Information about the object */ - //@{ + /** @{ */ /** * Return true if the given global index is in the local range of this @@ -1007,7 +1008,7 @@ public: */ void zero_out_ghost_values() const; - //@} + /** @} */ private: /** @@ -1043,7 +1044,7 @@ private: friend class Vector; }; -/*@}*/ +/** @} */ /*----------------------- Inline functions ----------------------------------*/ @@ -1386,8 +1387,9 @@ Vector::load(Archive &ar, const unsigned int) #endif -/*! @addtogroup Vectors - *@{ +/** + * @addtogroup Vectors + * @{ */ @@ -1429,7 +1431,7 @@ operator<<(std::ostream &out, const Vector &v) return out; } -/*@}*/ +/** @} */ /** diff --git a/include/deal.II/lac/vector_memory.h b/include/deal.II/lac/vector_memory.h index 9775ca0854..a397bd2668 100644 --- a/include/deal.II/lac/vector_memory.h +++ b/include/deal.II/lac/vector_memory.h @@ -32,8 +32,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup VMemory */ -/*@{*/ +/** + * @addtogroup VMemory + * @{ + */ /** * Memory management base class for vectors. This is an abstract base class @@ -162,7 +164,7 @@ public: "You are trying to deallocate a vector from a memory pool, but this " "vector has not actually been allocated by the same pool before."); - //@} + /** @} */ /** * A class that looks like a pointer for all practical purposes and that @@ -467,7 +469,7 @@ namespace internal } } // namespace internal -/*@}*/ +/** @} */ #ifndef DOXYGEN /* --------------------- inline functions ---------------------- */ diff --git a/include/deal.II/lac/vector_operation.h b/include/deal.II/lac/vector_operation.h index 5867ce9921..d73a01655c 100644 --- a/include/deal.II/lac/vector_operation.h +++ b/include/deal.II/lac/vector_operation.h @@ -20,8 +20,9 @@ DEAL_II_NAMESPACE_OPEN -/*! @addtogroup Vectors - *@{ +/** + * @addtogroup Vectors + * @{ */ /** @@ -62,7 +63,7 @@ struct VectorOperation }; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/lac/vector_space_vector.h b/include/deal.II/lac/vector_space_vector.h index 8817eb6ec3..78fc64822a 100644 --- a/include/deal.II/lac/vector_space_vector.h +++ b/include/deal.II/lac/vector_space_vector.h @@ -40,8 +40,9 @@ namespace LinearAlgebra namespace LinearAlgebra { - /*! @addtogroup Vectors - *@{ + /** + * @addtogroup Vectors + * @{ */ /** @@ -268,7 +269,7 @@ namespace LinearAlgebra */ virtual ~VectorSpaceVector() = default; }; - /*@}*/ + /** @} */ } // namespace LinearAlgebra // ---------------------------- Free functions -------------------------- diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index 16a639c76b..8f8b82ab80 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -107,7 +107,7 @@ public: /** * @name 1: Reading from and writing to vectors */ - //@{ + /** @{ */ /** * For the vector @p src, read out the values on the degrees of freedom of * the current cell, and store them internally. Similar functionality as the @@ -277,12 +277,12 @@ public: const std::bitset &mask = std::bitset().flip()) const; - //@} + /** @} */ /** * @name 2: Access to data at quadrature points or the gather vector data */ - //@{ + /** @{ */ /** * Return the value stored for the local degree of freedom with index @p * dof. If the object is vector-valued, a vector-valued return argument is @@ -578,7 +578,7 @@ public: value_type integrate_value() const; - //@} + /** @} */ /** * Return the underlying MatrixFree object. diff --git a/include/deal.II/matrix_free/fe_evaluation_data.h b/include/deal.II/matrix_free/fe_evaluation_data.h index da9d22100a..f6854fb0c6 100644 --- a/include/deal.II/matrix_free/fe_evaluation_data.h +++ b/include/deal.II/matrix_free/fe_evaluation_data.h @@ -169,7 +169,7 @@ public: /** * @name 1: Access to geometry data at quadrature points */ - //@{ + /** @{ */ /** * Return an ArrayView to internal memory for temporary use. Note that some @@ -223,12 +223,12 @@ public: Tensor<1, dim, Number> get_normal_vector(const unsigned int q_point) const; - //@} + /** @} */ /** * @name 2: Access to internal data arrays */ - //@{ + /** @{ */ /** * Return a read-only pointer to the first field of the dof values. This is * the data field the read_dof_values() functions write into. First come the @@ -335,12 +335,12 @@ public: Number * begin_hessians(); - //@} + /** @} */ /** * @name 3: Information about the current cell this class operates on */ - //@{ + /** @{ */ /** * Return the index offset within the geometry fields for the cell the @p @@ -543,12 +543,12 @@ public: std_cxx20::ranges::iota_view quadrature_point_indices() const; - //@} + /** @} */ /** * @name 3: Functions to access cell- and face-data vectors. */ - //@{ + /** @{ */ /** * Provides a unified interface to access data in a vector of @@ -626,7 +626,7 @@ public: set_face_data(AlignedVector> &array, const std::array & value) const; - //@} + /** @} */ /** * This data structure is used for the initialization by the derived diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 55113dbb6e..6717becfb6 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -549,7 +549,7 @@ public: /** * @name 1: Construction and initialization */ - //@{ + /** @{ */ /** * Default empty constructor. Does nothing. */ @@ -663,7 +663,7 @@ public: void clear(); - //@} + /** @} */ /** * This class defines the type of data access for face integrals in loop () @@ -742,7 +742,7 @@ public: /** * @name 2: Matrix-free loops */ - //@{ + /** @{ */ /** * This method runs the loop over all cells (in parallel) and performs the * MPI data exchange on the source vector and destination vector. @@ -1402,12 +1402,12 @@ public: get_face_active_fe_index(const std::pair range, const bool is_interior_face = true) const; - //@} + /** @} */ /** * @name 3: Initialization of vectors */ - //@{ + /** @{ */ /** * Initialize function for a vector with each entry associated with a cell * batch (cell data). For reading and writing the vector use: @@ -1517,12 +1517,12 @@ public: renumber_dofs(std::vector &renumbering, const unsigned int dof_handler_index = 0); - //@} + /** @} */ /** * @name 4: General information */ - //@{ + /** @{ */ /** * Return whether a given FiniteElement @p fe is supported by this class. */ @@ -1844,14 +1844,14 @@ public: void print(std::ostream &out) const; - //@} + /** @} */ /** * @name 5: Access of internal data structure * * Note: Expert mode, interface not stable between releases. */ - //@{ + /** @{ */ /** * Return information on task graph. */ @@ -1959,7 +1959,7 @@ public: release_scratch_data_non_threadsafe( const AlignedVector *memory) const; - //@} + /** @} */ private: /** diff --git a/include/deal.II/meshworker/assemble_flags.h b/include/deal.II/meshworker/assemble_flags.h index 15d2c7188a..98fedd0e20 100644 --- a/include/deal.II/meshworker/assemble_flags.h +++ b/include/deal.II/meshworker/assemble_flags.h @@ -24,8 +24,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup MeshWorker */ -/*@{*/ +/** + * @addtogroup MeshWorker + * @{ + */ namespace MeshWorker { @@ -195,7 +197,7 @@ namespace MeshWorker } } // namespace MeshWorker -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/meshworker/integration_info.h b/include/deal.II/meshworker/integration_info.h index 438c90c3f2..d27b4518f9 100644 --- a/include/deal.II/meshworker/integration_info.h +++ b/include/deal.II/meshworker/integration_info.h @@ -466,7 +466,7 @@ namespace MeshWorker * The quadrature rule used on interior faces. */ Quadrature face_quadrature; - /* @} */ + /** @} */ /** * @name Data vectors @@ -503,7 +503,7 @@ namespace MeshWorker std::shared_ptr> cell_data; std::shared_ptr> boundary_data; std::shared_ptr> face_data; - /* @} */ + /** @} */ /** * @name Interface for MeshWorker::loop() @@ -572,7 +572,7 @@ namespace MeshWorker */ CellInfo neighbor; - /* @} */ + /** @} */ }; diff --git a/include/deal.II/meshworker/scratch_data.h b/include/deal.II/meshworker/scratch_data.h index 9f401b8550..5e6299bf13 100644 --- a/include/deal.II/meshworker/scratch_data.h +++ b/include/deal.II/meshworker/scratch_data.h @@ -420,8 +420,8 @@ namespace MeshWorker /** * @name Methods to work on current cell + * @{ */ - /**@{*/ // CurrentCellMethods /** * Initialize the internal FEValues with the given @p cell, and return @@ -538,8 +538,8 @@ namespace MeshWorker /** * @name Methods to work on neighbor cell + * @{ */ - /** @{ */ // NeighborCellMethods /** * Initialize the internal neighbor FEValues to use the given @p cell, and diff --git a/include/deal.II/multigrid/mg_base.h b/include/deal.II/multigrid/mg_base.h index 2a9aacfea4..5324b1fb44 100644 --- a/include/deal.II/multigrid/mg_base.h +++ b/include/deal.II/multigrid/mg_base.h @@ -31,9 +31,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mg */ -/*@{*/ - +/** + * @addtogroup mg + * @{ + */ /** * Multilevel matrix base. This class sets up the interface needed by @@ -293,7 +294,7 @@ public: apply(const unsigned int level, VectorType &u, const VectorType &rhs) const; }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/multigrid/mg_block_smoother.h b/include/deal.II/multigrid/mg_block_smoother.h index 97a12a6570..f29c0dddd3 100644 --- a/include/deal.II/multigrid/mg_block_smoother.h +++ b/include/deal.II/multigrid/mg_block_smoother.h @@ -36,8 +36,10 @@ DEAL_II_NAMESPACE_OPEN * MGSmootherBase is defined in mg_base.h */ -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ /** * General smoother class for block vectors. This class gives complete freedom diff --git a/include/deal.II/multigrid/mg_coarse.h b/include/deal.II/multigrid/mg_coarse.h index bb0e327d6b..aefc1b4689 100644 --- a/include/deal.II/multigrid/mg_coarse.h +++ b/include/deal.II/multigrid/mg_coarse.h @@ -27,8 +27,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ /** * Coarse grid solver using smoother only. This is a little wrapper, @@ -237,7 +239,7 @@ private: LAPACKFullMatrix matrix; }; -/*@}*/ +/** @} */ #ifndef DOXYGEN /* ------------------ Functions for MGCoarseGridApplySmoother -----------*/ diff --git a/include/deal.II/multigrid/mg_matrix.h b/include/deal.II/multigrid/mg_matrix.h index 7831c90863..dbf15d45b8 100644 --- a/include/deal.II/multigrid/mg_matrix.h +++ b/include/deal.II/multigrid/mg_matrix.h @@ -30,8 +30,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ namespace mg { @@ -191,7 +193,7 @@ private: unsigned int col; }; -/*@}*/ +/** @} */ /*----------------------------------------------------------------------*/ diff --git a/include/deal.II/multigrid/mg_smoother.h b/include/deal.II/multigrid/mg_smoother.h index 1afe47c81c..b805774a02 100644 --- a/include/deal.II/multigrid/mg_smoother.h +++ b/include/deal.II/multigrid/mg_smoother.h @@ -35,8 +35,10 @@ DEAL_II_NAMESPACE_OPEN * MGSmootherBase is defined in mg_base.h */ -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ /** * A base class for smoother handling information on smoothing. While not @@ -579,7 +581,7 @@ private: MGLevelObject> matrices; }; -/*@}*/ +/** @} */ /* ------------------------------- Inline functions -------------------------- */ diff --git a/include/deal.II/multigrid/mg_tools.h b/include/deal.II/multigrid/mg_tools.h index ab8ff63317..b0c7af8b74 100644 --- a/include/deal.II/multigrid/mg_tools.h +++ b/include/deal.II/multigrid/mg_tools.h @@ -397,7 +397,7 @@ namespace MGTools } // namespace MGTools -/* @} */ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/multigrid/mg_transfer.h b/include/deal.II/multigrid/mg_transfer.h index 44adaf68ee..5927dfb371 100644 --- a/include/deal.II/multigrid/mg_transfer.h +++ b/include/deal.II/multigrid/mg_transfer.h @@ -237,10 +237,10 @@ namespace internal * MGTransferBase is defined in mg_base.h */ -/*!@addtogroup mg */ -/*@{*/ - - +/** + * @addtogroup mg + * @{ + */ /** * Implementation of transfer between the global vectors and the multigrid @@ -763,7 +763,7 @@ private: }; -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/multigrid/mg_transfer_block.h b/include/deal.II/multigrid/mg_transfer_block.h index 45ed511261..16843b1caf 100644 --- a/include/deal.II/multigrid/mg_transfer_block.h +++ b/include/deal.II/multigrid/mg_transfer_block.h @@ -46,8 +46,10 @@ class DoFHandler; * MGTransferBase is defined in mg_base.h */ -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ /** * Implementation of matrix generation for MGTransferBlock. @@ -456,7 +458,7 @@ private: unsigned int selected_block; }; -/*@}*/ +/** @} */ //------------------------- inline function definition ------------------------ template diff --git a/include/deal.II/multigrid/mg_transfer_component.h b/include/deal.II/multigrid/mg_transfer_component.h index fbb9c060b3..0f82d52fec 100644 --- a/include/deal.II/multigrid/mg_transfer_component.h +++ b/include/deal.II/multigrid/mg_transfer_component.h @@ -48,8 +48,10 @@ class DoFHandler; * MGTransferBase is defined in mg_base.h */ -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ /** * Implementation of matrix generation for component wise multigrid transfer. @@ -371,7 +373,7 @@ public: SmartPointer> constraints; }; -/*@}*/ +/** @} */ //--------------------------------------------------------------------------- template diff --git a/include/deal.II/multigrid/mg_transfer_matrix_free.h b/include/deal.II/multigrid/mg_transfer_matrix_free.h index d49ab0a1fd..af0f3ff9f3 100644 --- a/include/deal.II/multigrid/mg_transfer_matrix_free.h +++ b/include/deal.II/multigrid/mg_transfer_matrix_free.h @@ -35,8 +35,10 @@ DEAL_II_NAMESPACE_OPEN -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ /** * Implementation of the MGTransferBase interface for which the transfer @@ -539,7 +541,7 @@ private: }; -/*@}*/ +/** @} */ //------------------------ templated functions ------------------------- diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index 23a6b6d18f..34d4306660 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -43,8 +43,10 @@ and using the 'signals' keyword. You can either #include the Qt headers (or any *after* the deal.II headers or you can define the 'QT_NO_KEYWORDS' macro and use the 'Q_SIGNALS' macro." #endif -/*!@addtogroup mg */ -/*@{*/ +/** + * @addtogroup mg + * @{ + */ namespace mg { @@ -643,7 +645,7 @@ private: mg::Signals signals; }; -/*@}*/ +/** @} */ #ifndef DOXYGEN /* --------------------------- inline functions --------------------- */ diff --git a/include/deal.II/numerics/vector_tools_boundary.h b/include/deal.II/numerics/vector_tools_boundary.h index 0d139e1b25..52bead1a93 100644 --- a/include/deal.II/numerics/vector_tools_boundary.h +++ b/include/deal.II/numerics/vector_tools_boundary.h @@ -44,7 +44,7 @@ namespace VectorTools /** * @name Interpolation and projection */ - //@{ + /** @{ */ /** * Compute constraints on the solution that corresponds to the imposition diff --git a/include/deal.II/numerics/vector_tools_constraints.h b/include/deal.II/numerics/vector_tools_constraints.h index 0371942424..5b3aa88d08 100644 --- a/include/deal.II/numerics/vector_tools_constraints.h +++ b/include/deal.II/numerics/vector_tools_constraints.h @@ -41,7 +41,7 @@ namespace VectorTools /** * @name Interpolation and projection */ - //@{ + /** @{ */ /** * This function computes the constraints that correspond to boundary @@ -374,7 +374,7 @@ namespace VectorTools #endif )); - //@} + /** @} */ } // namespace VectorTools DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/vector_tools_integrate_difference.h b/include/deal.II/numerics/vector_tools_integrate_difference.h index 9afd7c1617..247123c186 100644 --- a/include/deal.II/numerics/vector_tools_integrate_difference.h +++ b/include/deal.II/numerics/vector_tools_integrate_difference.h @@ -47,7 +47,7 @@ namespace VectorTools /** * @name Evaluation of functions and errors */ - //@{ + /** @{ */ /** * Compute the cellwise error of the finite element solution. Integrate the @@ -229,7 +229,7 @@ namespace VectorTools const NormType & norm, const double exponent = 2.); - //@} + /** @} */ } // namespace VectorTools DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/vector_tools_interpolate.h b/include/deal.II/numerics/vector_tools_interpolate.h index c0c00718fb..490d6af7be 100644 --- a/include/deal.II/numerics/vector_tools_interpolate.h +++ b/include/deal.II/numerics/vector_tools_interpolate.h @@ -48,7 +48,7 @@ namespace VectorTools /** * @name Interpolation and projection */ - //@{ + /** @{ */ /** * Compute the interpolation of @p function at the support points to the @@ -248,12 +248,12 @@ namespace VectorTools const AffineConstraints &constraints, VectorType & u2); - //@} + /** @} */ /** * Geometrical interpolation */ - //@{ + /** @{ */ /** * Given a DoFHandler containing at least a spacedim vector field, this * function interpolates the Triangulation at the support points of a FE_Q() @@ -300,7 +300,7 @@ namespace VectorTools VectorType & vector, const ComponentMask & mask = ComponentMask()); - //@} + /** @} */ } // namespace VectorTools DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/vector_tools_mean_value.h b/include/deal.II/numerics/vector_tools_mean_value.h index b5923d9013..b2e5ddee2e 100644 --- a/include/deal.II/numerics/vector_tools_mean_value.h +++ b/include/deal.II/numerics/vector_tools_mean_value.h @@ -39,7 +39,7 @@ namespace VectorTools /** * Mean value operations */ - //@{ + /** @{ */ /** * Subtract the (algebraic) mean value from a vector. @@ -150,7 +150,7 @@ namespace VectorTools const Quadrature & quadrature, const VectorType & v, const unsigned int component); - //@} + /** @} */ } // namespace VectorTools DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/vector_tools_point_gradient.h b/include/deal.II/numerics/vector_tools_point_gradient.h index 208f618c36..76489a74e4 100644 --- a/include/deal.II/numerics/vector_tools_point_gradient.h +++ b/include/deal.II/numerics/vector_tools_point_gradient.h @@ -47,7 +47,7 @@ namespace VectorTools /** * @name Evaluation of functions and errors */ - //@{ + /** @{ */ /** * Evaluate a possibly vector-valued finite element function defined by the @@ -301,7 +301,7 @@ namespace VectorTools const VectorType & fe_function, const Point & point); - //@} + /** @} */ } // namespace VectorTools DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/vector_tools_point_value.h b/include/deal.II/numerics/vector_tools_point_value.h index 3129da0c61..0c1bd99b59 100644 --- a/include/deal.II/numerics/vector_tools_point_value.h +++ b/include/deal.II/numerics/vector_tools_point_value.h @@ -42,7 +42,7 @@ namespace VectorTools /** * @name Assembling of right hand sides */ - //@{ + /** @{ */ /** * Create a right hand side vector for a point source at point @p p. In @@ -217,7 +217,7 @@ namespace VectorTools /** * @name Evaluation of functions and errors */ - //@{ + /** @{ */ /** * Point error evaluation. Find the first cell containing the given point @@ -527,7 +527,7 @@ namespace VectorTools const DoFHandler & dof, const VectorType & fe_function, const Point & point); - //@} + /** @} */ } // namespace VectorTools DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/vector_tools_project.h b/include/deal.II/numerics/vector_tools_project.h index 4f635c43a6..0600e0ebbe 100644 --- a/include/deal.II/numerics/vector_tools_project.h +++ b/include/deal.II/numerics/vector_tools_project.h @@ -54,7 +54,7 @@ namespace VectorTools /** * @name Interpolation and projection */ - //@{ + /** @{ */ /** * Compute the projection of @p function to the finite element space. In other diff --git a/include/deal.II/numerics/vector_tools_rhs.h b/include/deal.II/numerics/vector_tools_rhs.h index 8e160ef940..60d20134e1 100644 --- a/include/deal.II/numerics/vector_tools_rhs.h +++ b/include/deal.II/numerics/vector_tools_rhs.h @@ -46,7 +46,7 @@ namespace VectorTools /** * @name Assembling of right hand sides */ - //@{ + /** @{ */ /** * Create a right hand side vector. Prior content of the given @p rhs_vector diff --git a/include/deal.II/opencascade/manifold_lib.h b/include/deal.II/opencascade/manifold_lib.h index 244a13f908..bffda1334b 100644 --- a/include/deal.II/opencascade/manifold_lib.h +++ b/include/deal.II/opencascade/manifold_lib.h @@ -418,7 +418,7 @@ namespace OpenCASCADE } // namespace OpenCASCADE -/*@}*/ +/** @} */ DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/physics/elasticity/kinematics.h b/include/deal.II/physics/elasticity/kinematics.h index f9fdd50560..1b0ab70d38 100644 --- a/include/deal.II/physics/elasticity/kinematics.h +++ b/include/deal.II/physics/elasticity/kinematics.h @@ -47,7 +47,7 @@ namespace Physics /** * @name Deformation tensors */ - //@{ + /** @{ */ /** * Return the deformation gradient tensor, @@ -134,12 +134,12 @@ namespace Physics DEAL_II_ALWAYS_INLINE SymmetricTensor<2, dim, Number> b(const Tensor<2, dim, Number> &F); - //@} + /** @} */ /** * @name Strain tensors */ - //@{ + /** @{ */ /** * Return the symmetric Green-Lagrange strain tensor, @@ -193,12 +193,12 @@ namespace Physics DEAL_II_ALWAYS_INLINE SymmetricTensor<2, dim, Number> e(const Tensor<2, dim, Number> &F); - //@} + /** @} */ /** * @name Strain rate tensors */ - //@{ + /** @{ */ /** * Return the spatial velocity gradient tensor, @@ -262,7 +262,7 @@ namespace Physics Tensor<2, dim, Number> w(const Tensor<2, dim, Number> &F, const Tensor<2, dim, Number> &dF_dt); - //@} + /** @} */ } // namespace Kinematics } // namespace Elasticity } // namespace Physics diff --git a/include/deal.II/physics/elasticity/standard_tensors.h b/include/deal.II/physics/elasticity/standard_tensors.h index 20ec58220d..306f7cd42f 100644 --- a/include/deal.II/physics/elasticity/standard_tensors.h +++ b/include/deal.II/physics/elasticity/standard_tensors.h @@ -49,7 +49,7 @@ namespace Physics /** * @name Metric tensors */ - //@{ + /** @{ */ /** * The second-order referential/spatial symmetric identity (metric) tensor @@ -124,12 +124,12 @@ namespace Physics #endif ; - //@} + /** @} */ /** * @name Projection operators */ - //@{ + /** @{ */ /** * The fourth-order spatial deviatoric tensor. Also known as the @@ -250,12 +250,12 @@ namespace Physics static DEAL_II_CONSTEXPR SymmetricTensor<4, dim, Number> Dev_P_T(const Tensor<2, dim, Number> &F); - //@} + /** @} */ /** * @name Scalar derivatives */ - //@{ + /** @{ */ /** * Return the derivative of the volumetric Jacobian * $J = \text{det} \mathbf{F}$ with respect to the right Cauchy-Green @@ -277,12 +277,12 @@ namespace Physics static DEAL_II_CONSTEXPR SymmetricTensor<2, dim, Number> ddet_F_dC(const Tensor<2, dim, Number> &F); - //@} + /** @} */ /** * @name Tensor derivatives */ - //@{ + /** @{ */ /** * Return the derivative of the inverse of the right Cauchy-Green @@ -302,7 +302,7 @@ namespace Physics static DEAL_II_CONSTEXPR SymmetricTensor<4, dim, Number> dC_inv_dC(const Tensor<2, dim, Number> &F); - //@} + /** @} */ }; } // namespace Elasticity diff --git a/include/deal.II/physics/notation.h b/include/deal.II/physics/notation.h index 43b7027801..28d09f74b3 100644 --- a/include/deal.II/physics/notation.h +++ b/include/deal.II/physics/notation.h @@ -337,7 +337,7 @@ namespace Physics /** * @name Forward operation: Tensor notation to Kelvin notation */ - //@{ + /** @{ */ /** * Convert a scalar value to its compressed vector equivalent. @@ -505,12 +505,12 @@ namespace Physics FullMatrix to_matrix(const SymmetricTensor<4, dim, Number> &st); - //@} + /** @} */ /** * @name Reverse operation: Kelvin notation to tensor notation */ - //@{ + /** @{ */ /** * Convert a compressed vector to its equivalent scalar value. @@ -640,7 +640,7 @@ namespace Physics template TensorType to_tensor(const FullMatrix &vec); - //@} + /** @} */ } // namespace Kelvin diff --git a/include/deal.II/physics/transformations.h b/include/deal.II/physics/transformations.h index 1472980482..14ef674d63 100644 --- a/include/deal.II/physics/transformations.h +++ b/include/deal.II/physics/transformations.h @@ -37,7 +37,7 @@ namespace Physics /** * @name Rotation matrices */ - //@{ + /** @{ */ /** * Return the rotation matrix for 2-d Euclidean space, namely @@ -100,7 +100,7 @@ namespace Physics DEAL_II_DEPRECATED Tensor<2, 3, Number> rotation_matrix_3d(const Point<3, Number> &axis, const Number &angle); - //@} + /** @} */ } // namespace Rotations @@ -125,7 +125,7 @@ namespace Physics /** * @name Push forward operations */ - //@{ + /** @{ */ /** * Return the result of the push forward transformation on a @@ -223,12 +223,12 @@ namespace Physics push_forward(const SymmetricTensor<4, dim, Number> &H, const Tensor<2, dim, Number> & F); - //@} + /** @} */ /** * @name Pull back operations */ - //@{ + /** @{ */ /** * Return the result of the pull back transformation on a contravariant @@ -324,7 +324,7 @@ namespace Physics pull_back(const SymmetricTensor<4, dim, Number> &h, const Tensor<2, dim, Number> & F); - //@} + /** @} */ } // namespace Contravariant /** @@ -350,7 +350,7 @@ namespace Physics /** * @name Push forward operations */ - //@{ + /** @{ */ /** * Return the result of the push forward transformation on a covariant @@ -448,12 +448,12 @@ namespace Physics push_forward(const SymmetricTensor<4, dim, Number> &H, const Tensor<2, dim, Number> & F); - //@} + /** @} */ /** * @name Pull back operations */ - //@{ + /** @{ */ /** * Return the result of the pull back transformation on a covariant @@ -549,7 +549,7 @@ namespace Physics pull_back(const SymmetricTensor<4, dim, Number> &h, const Tensor<2, dim, Number> & F); - //@} + /** @} */ } // namespace Covariant /** @@ -562,7 +562,7 @@ namespace Physics /** * @name Push forward operations */ - //@{ + /** @{ */ /** * Return the result of the push forward transformation on a @@ -668,12 +668,12 @@ namespace Physics push_forward(const SymmetricTensor<4, dim, Number> &H, const Tensor<2, dim, Number> & F); - //@} + /** @} */ /** * @name Pull back operations */ - //@{ + /** @{ */ /** * Return the result of the pull back transformation on a contravariant @@ -777,13 +777,13 @@ namespace Physics pull_back(const SymmetricTensor<4, dim, Number> &h, const Tensor<2, dim, Number> & F); - //@} + /** @} */ } // namespace Piola /** * @name Special operations */ - //@{ + /** @{ */ /** * Return the result of applying Nanson's formula for the transformation @@ -812,12 +812,12 @@ namespace Physics nansons_formula(const Tensor<1, dim, Number> &N, const Tensor<2, dim, Number> &F); - //@} + /** @} */ /** * @name Basis transformations */ - //@{ + /** @{ */ /** * Return a vector with a changed basis, i.e. @@ -897,7 +897,7 @@ namespace Physics basis_transformation(const SymmetricTensor<4, dim, Number> &H, const Tensor<2, dim, Number> & B); - //@} + /** @} */ } // namespace Transformations } // namespace Physics -- 2.39.5