]> https://gitweb.dealii.org/ - dealii.git/commitdiff
epic doxygen fixes
authorTimo Heister <timo.heister@gmail.com>
Thu, 21 Jul 2022 21:41:26 +0000 (17:41 -0400)
committerTimo Heister <timo.heister@gmail.com>
Thu, 21 Jul 2022 21:41:26 +0000 (17:41 -0400)
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

163 files changed:
doc/doxygen/headers/iterators.h
include/deal.II/algorithms/general_data_storage.h
include/deal.II/base/convergence_table.h
include/deal.II/base/data_out_base.h
include/deal.II/base/exceptions.h
include/deal.II/base/function_parser.h
include/deal.II/base/mu_parser_internal.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/patterns.h
include/deal.II/base/qprojector.h
include/deal.II/base/quadrature.h
include/deal.II/base/quadrature_lib.h
include/deal.II/base/quadrature_point_data.h
include/deal.II/base/quadrature_selector.h
include/deal.II/base/subscriptor.h
include/deal.II/base/table_handler.h
include/deal.II/base/tensor.h
include/deal.II/base/tensor_function_parser.h
include/deal.II/base/thread_local_storage.h
include/deal.II/base/thread_management.h
include/deal.II/base/vectorization.h
include/deal.II/differentiation/ad/ad_drivers.h
include/deal.II/differentiation/ad/ad_helpers.h
include/deal.II/differentiation/sd/symengine_math.h
include/deal.II/differentiation/sd/symengine_number_types.h
include/deal.II/differentiation/sd/symengine_optimizer.h
include/deal.II/differentiation/sd/symengine_scalar_operations.h
include/deal.II/differentiation/sd/symengine_tensor_operations.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_abf.h
include/deal.II/fe/fe_bernstein.h
include/deal.II/fe/fe_dgp.h
include/deal.II/fe/fe_dgp_monomial.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_dgq.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_interface_values.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_nedelec_sz.h
include/deal.II/fe/fe_nothing.h
include/deal.II/fe/fe_p1nc.h
include/deal.II/fe/fe_poly.h
include/deal.II/fe/fe_poly_face.h
include/deal.II/fe/fe_q.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_q_bubbles.h
include/deal.II/fe/fe_q_dg0.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_q_iso_q1.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/fe/fe_series.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_update_flags.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping_c1.h
include/deal.II/fe/mapping_cartesian.h
include/deal.II/fe/mapping_fe.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/fe/mapping_q.h
include/deal.II/fe/mapping_q1.h
include/deal.II/fe/mapping_q1_eulerian.h
include/deal.II/fe/mapping_q_cache.h
include/deal.II/fe/mapping_q_eulerian.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria_iterator.h
include/deal.II/lac/block_indices.h
include/deal.II/lac/block_linear_operator.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/constrained_linear_operator.h
include/deal.II/lac/cuda_sparse_matrix.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/eigen.h
include/deal.II/lac/exceptions.h
include/deal.II/lac/full_matrix.h
include/deal.II/lac/householder.h
include/deal.II/lac/identity_matrix.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/la_vector.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/packaged_operation.h
include/deal.II/lac/petsc_block_sparse_matrix.h
include/deal.II/lac/petsc_block_vector.h
include/deal.II/lac/petsc_full_matrix.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_vector.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/schur_complement.h
include/deal.II/lac/solver_bicgstab.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_fire.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/solver_idr.h
include/deal.II/lac/solver_minres.h
include/deal.II/lac/solver_qmrs.h
include/deal.II/lac/solver_richardson.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/sparse_decomposition.h
include/deal.II/lac/sparse_ilu.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_mic.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/sparsity_tools.h
include/deal.II/lac/tridiagonal_matrix.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_linear_operator.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector_memory.h
include/deal.II/lac/vector_operation.h
include/deal.II/lac/vector_space_vector.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/fe_evaluation_data.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/meshworker/assemble_flags.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/scratch_data.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_block_smoother.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/multigrid/mg_matrix.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/multigrid/mg_tools.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/multigrid/multigrid.h
include/deal.II/numerics/vector_tools_boundary.h
include/deal.II/numerics/vector_tools_constraints.h
include/deal.II/numerics/vector_tools_integrate_difference.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/numerics/vector_tools_mean_value.h
include/deal.II/numerics/vector_tools_point_gradient.h
include/deal.II/numerics/vector_tools_point_value.h
include/deal.II/numerics/vector_tools_project.h
include/deal.II/numerics/vector_tools_rhs.h
include/deal.II/opencascade/manifold_lib.h
include/deal.II/physics/elasticity/kinematics.h
include/deal.II/physics/elasticity/standard_tensors.h
include/deal.II/physics/notation.h
include/deal.II/physics/transformations.h

index ed085fc12885ffa2d30dac525e2d45243a3dd041..e745a344d345f0162f9731267a31bc0113ba18ed 100644 (file)
@@ -383,7 +383,7 @@ levels, and accessors for objects of lower dimensionality do not have a
 @ingroup grid
 */
 
-//@}
+/** @} */
 
 
 /**
index ac7dcac3ed894c1980cfc28593300672c47c21ca..78b90d7a86be9402a80f80ba881e6965949318e1 100644 (file)
@@ -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.
index 5c105c293128a91209c4f79efaa3f1a1ea075858..a6e28465657357de60e29be79f5ac4553261017a 100644 (file)
@@ -213,7 +213,7 @@ public:
   DeclException1(ExcRateColumnAlreadyExists,
                  std::string,
                  << "Rate column <" << arg1 << "> does already exist.");
-  //@}
+  /** @} */
 };
 
 
index 3027abb5e2f961692f67febc4b6ee07f0e08b0d7..50110300152033fd139dbc79d6f1c05c5d25d0a8 100644 (file)
@@ -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
 
 
index 2f2499ea6b1e55a40acedcf0f2c4118641df0cec..b2412c3eb7a358d50dcf21b88c5599d52d605db5 100644 (file)
@@ -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.
index f3367608830c268afd8b4c4ee0782eb8d6fe070b..d2654c2b1e67b6557ddb9f9af1f4917aadfb359a 100644 (file)
@@ -368,7 +368,7 @@ public:
                  << ") is not equal to the number of expressions (" << arg2
                  << ").");
 
-  //@}
+  /** @} */
 };
 
 
index 679473ae9366a43ac015faca4d91c413eb9bb67e..8103e6468e3b7aba58e4c83144cf934a06302e29 100644 (file)
@@ -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
index 3caf72b6acf517e330ecf01886965078f1e5faa6..ac91eaeadccee60eae0cf9892f8e7bd1b8504d09 100644 (file)
@@ -1716,7 +1716,7 @@ public:
        "file to include <"
     << arg3 << "> cannot be opened.");
 
-  //@}
+  /** @} */
 
 private:
   /**
index a0113770713326c98fe26aed2f635562ac07ea4b..5d45d09c1bbecb71e8214bfe25d6ebb60d2ed6ed 100644 (file)
@@ -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
 
index 45c98f972ac2ec6442a6c2e2e1ee159ec99d313a..a30dd2b3aa21bea39669861c3852ee7728b3e19f 100644 (file)
 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 ----------------
index 04138d2a8ec70f2feb54be7a3c83855208533973..d1013e76b955299a9ef0cb422b48b6294872047f 100644 (file)
 
 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
 
index 87b2718a06c41fab5bd06a27a468c2933b7cc041..01669fa365f9080a85b233502a0d6d77fbe071be 100644 (file)
 
 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 ------------- */
 
index f64933bffcfce90daf3518ce77b44c95045e490a..2927a841d95042563c7c1e56a6f921ac1b092016 100644 (file)
 
 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
 
index f00defadfffd48f30ae88beb869098cd9b481254..bda00c967c642f45e0441f9b1af5b7c7a68012d7 100644 (file)
@@ -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
index efb009547b52f4102a4f0aba7147cad2bdee4993..b1d787b2b2c1f9c0b50aaee403fb4281ee188db8 100644 (file)
@@ -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
index 451cc2c180060d920a0ffa2867d7d95113260585..15cf1e7f20d2f67fff572b1036bd60572c30f4c3 100644 (file)
@@ -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
index c9798ba3834d3f5c48acbe6aef6ae98ba94261f6..4cde9bde1834bae1e47fefba75ccfe0af5193dd7 100644 (file)
@@ -1889,8 +1889,8 @@ constexpr unsigned int Tensor<rank_, dim, Number>::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
index 969eb4b36a4f4902b701e89c7674a58899c9d0bb..ea316d31b8e01f64d0e29607ad480bf8479ebb50 100644 (file)
@@ -260,7 +260,7 @@ public:
                  << ") is not equal to the number of expressions (" << arg2
                  << ").");
 
-  //@}
+  /** @} */
 private:
   /**
    * Number of components is equal dim<sup>rank</sup>.
index 6da118575b8a06f62191cdd7c6a7857698804aa1..d7d5814fad45cbf91f6b5095c78c25211ce3f51d 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup threads */
-/*@{*/
+/**
+ * @addtogroup threads
+ * @{
+ */
 
 #  ifndef DOXYGEN
 class LogStream;
index fd8e2d12a652c08658032f407c516497a1d3ffcf..2929308f3d84c71f62e0013efedbc6a8e8c4ebfa 100644 (file)
@@ -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
index 02a02d73fbf267abe510d624c7180f7c5324c51e..9f586379115c9e41efcaa9da0ed3331c9bb0e697 100644 (file)
@@ -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<Number, width> &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<Number, 1> &left,
   return result;
 }
 
-//@}
+/** @} */
 
 #ifndef DOXYGEN
 #  if DEAL_II_VECTORIZATION_WIDTH_IN_BITS >= 512 && defined(__AVX512F__)
index d6820f2c0f6f960a04eebbd3b5699fa7ecd5cac1..ba25b55419b2c973724ac6436e14b0872e8ad951 100644 (file)
@@ -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<ADNumberType>::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<ScalarType> &independent_variables,
               FullMatrix<ScalarType> &       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<ScalarType> &independent_variables,
                FullMatrix<ScalarType> &       jacobian) const;
 
-      //@}
+      /** @} */
     };
 
 
@@ -523,8 +523,8 @@ namespace Differentiation
 
       /**
        * @name Configuration
+       * @{
        */
-      //@{
 
       /**
        * In the event that the tapeless mode requires <i>a priori</i> 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<ADNumberType> &dependent_variables,
               FullMatrix<ScalarType> &         hessian) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for vector functions
+       * @{
        */
-      //@{
 
       /**
        * Compute the values of the vector field.
@@ -670,7 +670,7 @@ namespace Differentiation
                const std::vector<ADNumberType> &dependent_variables,
                FullMatrix<ScalarType> &         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<ADNumberType>::tape_index tape_index,
         std::ostream &                                 stream) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for scalar functions (one dependent variable)
+       * @{
        */
-      //@{
 
       scalar_type
       value(const typename Types<ADNumberType>::tape_index active_tape_index,
@@ -856,12 +856,12 @@ namespace Differentiation
               const std::vector<scalar_type> &independent_variables,
               FullMatrix<scalar_type> &       hessian) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for vector functions (multiple dependent variables)
+       * @{
        */
-      //@{
 
       void
       values(const typename Types<ADNumberType>::tape_index active_tape_index,
@@ -875,7 +875,7 @@ namespace Differentiation
                const std::vector<scalar_type> &independent_variables,
                FullMatrix<scalar_type> &       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<ADNumberType>::tape_index,
                        std::ostream &) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for scalar functions (one dependent variable)
+       * @{
        */
-      //@{
 
       scalar_type
       value(const typename Types<ADNumberType>::tape_index,
@@ -1052,12 +1052,12 @@ namespace Differentiation
               const std::vector<scalar_type> &,
               FullMatrix<scalar_type> &) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for vector functions (multiple dependent variables)
+       * @{
        */
-      //@{
 
       void
       values(const typename Types<ADNumberType>::tape_index,
@@ -1071,7 +1071,7 @@ namespace Differentiation
                const std::vector<scalar_type> &,
                FullMatrix<scalar_type> &) 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<ADNumberType>::tape_index tape_index,
         std::ostream &                                 stream) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for scalar functions (one dependent variable)
+       * @{
        */
-      //@{
 
       scalar_type
       value(const typename Types<ADNumberType>::tape_index active_tape_index,
@@ -1175,12 +1175,12 @@ namespace Differentiation
               const std::vector<scalar_type> &independent_variables,
               FullMatrix<scalar_type> &       hessian) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for vector functions (multiple dependent variables)
+       * @{
        */
-      //@{
 
       void
       values(const typename Types<ADNumberType>::tape_index active_tape_index,
@@ -1194,7 +1194,7 @@ namespace Differentiation
                const std::vector<scalar_type> &independent_variables,
                FullMatrix<scalar_type> &       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<ADNumberType> &dependent_variables) const;
@@ -1276,12 +1276,12 @@ namespace Differentiation
               const std::vector<ADNumberType> &dependent_variables,
               FullMatrix<ScalarType> &         hessian) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for vector functions
+       * @{
        */
-      //@{
 
       void
       values(const std::vector<ADNumberType> &dependent_variables,
@@ -1292,7 +1292,7 @@ namespace Differentiation
                const std::vector<ADNumberType> &dependent_variables,
                FullMatrix<ScalarType> &         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<ADNumberType> &dependent_variables) const;
@@ -1368,12 +1368,12 @@ namespace Differentiation
               const std::vector<ADNumberType> &dependent_variables,
               FullMatrix<ScalarType> &         hessian) const;
 
-      //@}
+      /** @} */
 
       /**
        * @name Drivers for vector functions
+       * @{
        */
-      //@{
 
       void
       values(const std::vector<ADNumberType> &dependent_variables,
@@ -1384,7 +1384,7 @@ namespace Differentiation
                const std::vector<ADNumberType> &dependent_variables,
                FullMatrix<ScalarType> &         jacobian) const;
 
-      //@}
+      /** @} */
 
     private:
       /**
index 3a8c1dafb7a408218971786685c94cb70e4ed4a4..ebf4cfd287ad7f65197c57f810c029721d54d0e5 100644 (file)
@@ -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<ad_type>::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<ad_type>::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<ad_type> &
       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<dealii::types::global_dof_index> &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<scalar_type> &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<scalar_type> &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<scalar_type> &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<ad_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<bool> 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
 
index 38b7c7e4714bc82e3aaf974de7a9a809118f9f9f..9bdd112d537a2aa879846a204b1ac9ff0ee9dd53 100644 (file)
@@ -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
index a90c29470bc8ac2c5ed561a3b92b4988f95feba9..2620db3a88d98fa5edff7bbd35bab086c29ed053 100644 (file)
@@ -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<const SymEngine::Basic> &
       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<const SymEngine::Basic> &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 SymEngine::Basic> &() 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<Expression> : 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
index caeddd3d81bf147db930dc684289c5f5a8d4e65f..527ed298a37ce15680d53b19486d679cad37964d 100644 (file)
@@ -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<rank, dim, Expression> &funcs,
               const std::vector<ReturnType> &cached_evaluation) const;
 
-      //@}
+      /** @} */
 
     private:
       /**
index 505376e77d1704b4168c8fd7fddd53281d5d0838..b3db90d27b37eedd29796121155839dc4127fe75 100644 (file)
@@ -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<ExpressionType, ValueType> &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
index 1a617e20812a6d241f20806ab776b36878c42bde..f1b7aac0c7ccf280a4a4ba089b747b270ea9258b 100644 (file)
@@ -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<rank_1, dim, Expression> &S,
                   const Tensor<rank_2, dim, Expression> &         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<rank, dim, SymbolicType> &symbol_tensor,
       const SymmetricTensor<rank, dim, ValueType> &   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<rank, dim, ExpressionType> &symbol_tensor,
       const SymmetricTensor<rank, dim, ValueType> &     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<rank, dim, ExpressionType> &symbol_tensor,
       const SymmetricTensor<rank, dim, ValueType> &     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<rank, dim, Expression> &expression_tensor,
       const types::substitution_map &               substitution_map);
 
-    //@}
+    /** @} */
 
   } // namespace SD
 } // namespace Differentiation
index 3e3b3079307cd1f2ef095950a8be19060ff506b7..d26eec2e40c3b1543613e2ae325b558c394e9683 100644 (file)
@@ -1499,7 +1499,7 @@ namespace DoFTools
   extract_constant_modes(const DoFHandler<dim, spacedim> &dof_handler,
                          const ComponentMask &            component_mask,
                          std::vector<std::vector<bool>> & 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
index 0b818df32a586ad6537740f29776206437333549..9ceacd17ad63df14faadad3fafb60810013a4080 100644 (file)
@@ -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<dim, spacedim> &source,
                            FullMatrix<double> &                matrix) const;
-  //@}
+  /** @} */
 
   /**
    * @name Functions to support hp-adaptivity
@@ -1290,7 +1290,7 @@ public:
                                    const unsigned int                  subface,
                                    FullMatrix<double> &                matrix,
                                    const unsigned int face_no = 0) const;
-  //@}
+  /** @} */
 
 
   /**
@@ -1350,7 +1350,7 @@ public:
   compare_for_domination(const FiniteElement<dim, spacedim> &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<Table<2, bool>, std::vector<unsigned int>>
   get_constant_modes() const;
 
-  //@}
+  /** @} */
 
   /**
    * @name Support points and interpolation
@@ -2250,7 +2250,7 @@ public:
     const std::vector<Vector<double>> &support_point_values,
     std::vector<double> &              nodal_values) const;
 
-  //@}
+  /** @} */
 
   /**
    * Determine an estimate for the memory consumption (in bytes) of this
index b170c180a003955d5da0b0e67b92cd2e106c7ada..5332dde9d52711d796b7ff50527d1edb5ba5ebbd 100644 (file)
 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
index 4d471eef78f227b38c906c3f57003eece96c296f..c7d3740d2bbbf5cd6bf5bca86351d068231f7779 100644 (file)
 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
 
index c244f435bf0c9ab31426285e5c35a996391d190d..c74cebcbe183e92bafa92b7cfe9d96eac12176f1 100644 (file)
 
 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
 
index 833a5462c2afd7928c7a2eb5f187b3a906871c75..9cd3527651fbcf6c6317c2c56eecef99fa3a8bcb 100644 (file)
 
 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
 
index 755f5d106cdb64febd8960eadc96fa6851775618..76a32e8cbfe2a7d1a6e86d63a86a4f54bb4ef4d1 100644 (file)
 
 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
 
index a45310ed047a6aeaf7d0691651a13b31787ecbef..766573195384ecdcd929edc1f6e7b0184485b674 100644 (file)
@@ -33,8 +33,10 @@ template <int dim>
 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
 
index 65bb51fe96b94d4731a47c32a5b832c740ba2f40..0d70f58d3a34715befff22c8c5c4d274c910c2a0 100644 (file)
@@ -329,7 +329,7 @@ public:
     const RefinementCase<dim> &refinement_case =
       RefinementCase<dim>::isotropic_refinement) const override;
 
-  //@}
+  /** @} */
 
   /**
    * @name Functions to support hp
@@ -423,7 +423,7 @@ public:
   compare_for_domination(const FiniteElement<dim, spacedim> &fe_other,
                          const unsigned int codim = 0) const override final;
 
-  //@}
+  /** @} */
 
 
   /**
index 3616755787e690975bdc8798074ca0ccd4b82602..b45be9d32e894d0f66e7cdd7504b7e8f67524863 100644 (file)
@@ -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<solution_value_type<typename InputVector::value_type>>
         &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<typename InputVector::value_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<solution_hessian_type<typename InputVector::value_type>>
         &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<solution_value_type<typename InputVector::value_type>>
         &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<typename InputVector::value_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<solution_hessian_type<typename InputVector::value_type>>
         &hessians) const;
 
-    //@}
+    /** @} */
 
   private:
     /**
@@ -2019,12 +2019,12 @@ public:
     std::vector<Tensor<3, spacedim, typename InputVector::value_type>>
       &third_derivatives) const;
 
-  //@}
+  /** @} */
 
   /**
    * @name Access to the average of the function values and derivatives
    */
-  //@{
+  /** @{ */
 
   /**
    * Return the average of the values of the
index 435e954e4a82acd04dd408396250aac078aab84e..ec2f223935f35b527e02c711124c1bd21977b4ee 100644 (file)
 
 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
 
index a77a547a82dc2bd19c916494ae9cdeec4bc8ff08..043164c345b2b8cfce0bfc2ee6106b9c62f0e897 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup fe */
-/*@{*/
+/**
+ * @addtogroup fe
+ * @{
+ */
 
 /**
  * This class represents an implementation of the
@@ -458,7 +460,7 @@ private:
 
 
 
-/*@}*/
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index e5d879f333ef620f460071370537ade337f75c12..a81cc644088420bbc6ac700a30cbf0093e13eb64 100644 (file)
 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
 
index a73cf033d1578f8e510d2d93e64dcb5124d7867c..c0d266e1badf7f3336c770769bef50d01802a430 100644 (file)
 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
index 934388f75720ab8a3b5ff5d005004cd9d00a3eff..7752b281f145fea7b6623548fdb3457c923519e5 100644 (file)
 
 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<ScalarPolynomialsBase<dim>> poly_space;
 };
 
-/*@}*/
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index d2348767f868161f42d4c8bfda5dc0489cf200ca..b1e1085ff6b0188e7e2a0cf88e705f88a43e378f 100644 (file)
 
 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
 
index f451b7df8d63e8827cca8bf31bc04688ac8d1b90..a799b9466c2a6aa7d22d869ff6b5f799ea1316fb 100644 (file)
 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
 
index 9aa89860740c1902d8ccfdbe8b6368086b422889..e9c70005ae3b2fc8e29eb661faaf51ab388facb8 100644 (file)
 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<dim, spacedim> &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
 
index 5aa094d14669da9dfedfd1d7b96f454595db07ed..7f7b7046aa30e09b4ef146cd62e2cb63794387a3 100644 (file)
 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
index 1719633d5377ba8e14e87cd36f9379b4369be916..7f45c328dc3694112f8202f8a262ffe60b5b8b9d 100644 (file)
 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
index 5ceb325039cc5d4a15b5a772bcc111d42abd630c..adc948207877029e0505d6e976a93f955e1c5daa 100644 (file)
 
 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<dim> &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 ------------- */
 
index 314e7621a0ca9d1cc09e929c92bd932b37ee09cd..e25255dda40ac0b73505eb32d8097991eba42250 100644 (file)
 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<dim, spacedim> &fe_other,
                          const unsigned int codim = 0) const override final;
 
-  //@}
+  /** @} */
 };
 
 
 
-/*@}*/
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index 1a4c77595f16e48b332aa6281c08c9622945487a..e2852b4e6f8bc0833ff344bc3724e2d3d26565f3 100644 (file)
 
 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 ------------- */
 
index 814a86cf482f3b2d1d3c272bd32e96ca6f032a1c..7e10c33f3e579090f184d5b0f0a8abe16bbd941d 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-/*!@addtogroup feall */
-/*@{*/
+/**
+ * @addtogroup fe
+ * @{
+ */
 
 
 /**
@@ -412,7 +414,7 @@ namespace FESeries
 
 } // namespace FESeries
 
-/*@}*/
+/** @} */
 
 
 
index 2a86623626ddd4b91d73821a5f19ce9b7d416190..45194ce5c6a4e95963a798e2b0471d0013558cb5 100644 (file)
@@ -1017,7 +1017,7 @@ public:
   compare_for_domination(const FiniteElement<dim, spacedim> &fe_other,
                          const unsigned int codim = 0) const override final;
 
-  //@}
+  /** @} */
 
   /**
    * Implementation of the
index f8d2b0b9f6df7fbf2a1de2acc10e9cf8c8e526e2..b62f549df825388b178148362c393ace3c5ba1bf 100644 (file)
@@ -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<typename OutVector::value_type> &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
 
index 38a0f71c4edc62e8c2b9b5b945446e1e4826a78d..b17d55053d186d0df3520ffea6a98b56085a0810 100644 (file)
@@ -35,8 +35,8 @@ template <int, int>
 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
 
 
-/*@}*/
+/** @} */
 
 
 
index 2611e781d0e569496eb8f7545bfded9e541644bd..d1a94afed87887a453495601b47539000ea93482 100644 (file)
@@ -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<std::vector<typename InputVector::value_type>> 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<std::vector<typename InputVector::value_type>> &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<Tensor<3, spacedim, typename InputVector::value_type>>>
                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<unsigned int, unsigned int>
   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<Tensor<1, spacedim>> &
   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;
-  //@}
+  /** @} */
 
 
   /**
index 22574def6f5690b9cfe3d29953888f3c3941adc1..74b674a447a8b6063d2ba20aa385a2dec2b8410d 100644 (file)
 
 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<Point<dim>> &                         a) const override;
 };
 
-/*@}*/
+/** @} */
 
 /* -------------- declaration of explicit specializations ------------- */
 
index e2838213d7911f1a25b767e2d96500ef4f1049c7..93df82c2fe21197249c7b8d9a7ab17dcae120135 100644 (file)
 
 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
 
index 529d75e54857aa102d60776a4644a8ec23cacb67..3941a098bc78a864f51180ed6f0154b8d485862f 100644 (file)
 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:
 
 
 
-/*@}*/
+/** @} */
 
 /*----------------------------------------------------------------------*/
 
index 1db832688e3f7848e55b3109a07bd8438400d96b..4bf581d9824d636600cc37de646c773be6721b10 100644 (file)
 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 ------------- */
 
index 7639eee65bdf303d2651633ab538ec0d9efea0e9..0ac895c6c346d004341c95daf41228cd53e7456e 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup mapping */
-/*@{*/
-
+/**
+ * @addtogroup mapping
+ * @{
+ */
 
 /**
  * This class implements the functionality for Manifold conforming
@@ -385,7 +386,7 @@ private:
 
 
 
-/*@}*/
+/** @} */
 
 /*----------------------------------------------------------------------*/
 
index 801554d6182ad7c06e12d1405ab8e2b35ee1dc96..ec5750303d38ce73135f530636b2b290bdaf8e0e 100644 (file)
@@ -42,9 +42,10 @@ template <int, int>
 class MappingQCache;
 #endif
 
-/*!@addtogroup mapping */
-/*@{*/
-
+/**
+ * @addtogroup mapping
+ * @{
+ */
 
 /**
  * This class implements the functionality for polynomial mappings $Q_p$ of
@@ -794,7 +795,7 @@ protected:
 template <int dim, int spacedim = dim>
 using MappingQGeneric = MappingQ<dim, spacedim>;
 
-/*@}*/
+/** @} */
 
 
 /*----------------------------------------------------------------------*/
index cccdec4f2757641a2a22b1ae7657d71e50c94eb8..b9b86451b0c39ca265c4c216f29156ac6e817fdc 100644 (file)
 
 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
index 0aeb7a862ca2d7f8b999261692110e6239b9898c..fab46969a1b5f22afdba8edbcb3d6e918b073a81 100644 (file)
@@ -32,8 +32,10 @@ template <typename>
 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;
 };
 
-/*@}*/
+/** @} */
 
 /*----------------------------------------------------------------------*/
 
index 96cb1988202cf1247eb6c624b62169c251eaec30..734e5d982f5a7787a95eb8713197fe5178d08eb5 100644 (file)
@@ -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
 
index dc34260652d3b6914811c1b28a6387c1fa2ba906..e5802040c4f242fb0e9bc2d4070291e06be9c093 100644 (file)
@@ -37,8 +37,10 @@ template <typename>
 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;
 };
 
-/*@}*/
+/** @} */
 
 
 /*----------------------------------------------------------------------*/
index 73865b5f29ca23252e89116148d42a5beb5ee87e..59bc5a25d9a375c80f4abc260ee9e03a857705c6 100644 (file)
@@ -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<types::boundary_id> &boundary_ids =
                           std::set<types::boundary_id>());
 
-  ///@}
+  //** @} */
 
 
   /**
    * @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
index 5a0d81622928cf469b4ff552b697c702cd5db709..73e29905702e66c94cfd6013e7bfb5fee4a834f0 100644 (file)
@@ -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<Point<spacedim>>, std::vector<CellData<dim>>, SubCellData>
     get_coarse_mesh_description(const Triangulation<dim, spacedim> &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<CellData<dim>> &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<dim, spacedim> &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<dim, spacedim>::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<bool>
   get_locally_owned_vertices(const Triangulation<dim, spacedim> &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<dim, spacedim> &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<double> &matrix = FullMatrix<double>());
 
-  /*@}*/
+  /** @} */
   /**
    * @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*/
 
index bfed183f299d48e801bfef903e5f9e5e2e93e13e..2424c7fd1be84fe49724a8c132ad13c2d02fe6ec 100644 (file)
@@ -319,7 +319,7 @@ public:
   /**
    * @name Dereferencing
    */
-  /*@{*/
+  /** @{ */
   /**
    * Dereferencing operator, returns a reference to an accessor. Usage is thus
    * like <tt>(*i).index ();</tt>
@@ -369,7 +369,7 @@ public:
   const Accessor &
   access_any() const;
 
-  /*@}*/
+  /** @} */
 
   /**
    * Assignment operator.
@@ -428,7 +428,7 @@ public:
   /**
    * @name Advancement of iterators
    */
-  /*@{*/
+  /** @{ */
   /**
    * Prefix <tt>++</tt> operator: <tt>++iterator</tt>. 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 <tt>++</tt> operator: <tt>++i</tt>. This operator advances the
    * iterator to the next used element and returns a reference to
@@ -727,7 +727,7 @@ public:
    */
   TriaIterator<Accessor>
   operator--(int);
-  /*@}*/
+  /** @} */
 
   /**
    * Declare some aliases which are standard for iterators and are used
@@ -903,7 +903,7 @@ public:
   /**
    * @name Advancement of iterators
    */
-  /*@{*/
+  /** @{ */
   /**
    * Postfix <tt>++</tt> operator: <tt>i++</tt>. This operator advances the
    * iterator to the next active element, but returns an iterator to the
@@ -928,7 +928,7 @@ public:
    */
   TriaActiveIterator<Accessor>
   operator--(int);
-  /*@}*/
+  /** @} */
 
   /**
    * Declare some alias which are standard for iterators and are used
index 69d21b88c0a732f3fe046a9c0930447e9c4344cb..8444237e8201926bb21457c9d5dcd1c675a3b65a 100644 (file)
@@ -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.
index dd1df1454306392e24866265108caeefb813cf2e..7ffdbea54ac83dc92daf23bc6700fbd0d4c10826 100644 (file)
@@ -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
 
index 0493c8616057f11f61c5519ffe13bbeedea1f7f8..a478a68f3b44dace33e91e4edd7248d50dcb4a58 100644 (file)
@@ -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 ---------------------- */
index 2eca7cb924790bb208daf254efb67a9eff56d81f..c018c460b514913ca098c54a8ea34a9fe025b105 100644 (file)
@@ -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<nonblock_number> &      dst,
          const Vector<nonblock_number> &src) const;
-  //@}
+  /** @} */
 
   /**
    * @name Preconditioning methods
    */
-  //@{
+  /** @{ */
   /**
    * Apply the Jacobi preconditioner, which multiplies every element of the
    * <tt>src</tt> vector by the inverse of the respective diagonal element and
@@ -312,12 +313,12 @@ public:
   precondition_Jacobi(Vector<number2> &      dst,
                       const Vector<number2> &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 ---------------------- */
 
 
index 761297cb3f7136641e3184d30e6ebb4579746208..64cdce6ecb309987ef206334d5c9d0d91efe7206 100644 (file)
@@ -40,8 +40,9 @@ template <typename Number>
 class BlockVector;
 #endif
 
-/*! @addtogroup Matrix1
- *@{
+/**
+ * @addtogroup Matrix1
+ * @{
  */
 
 
@@ -263,7 +264,7 @@ private:
   Table<2, SparseMatrixEZ<Number>> blocks;
 };
 
-/*@}*/
+/** @} */
 /*----------------------------------------------------------------------*/
 
 
index d613c5a4407ed1d7e6ef1bf527798b206558bc51..a801c04e0a967265a6f2ccce77e51e922eefa8a1 100644 (file)
@@ -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<DynamicSparsityPattern>::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<SparsityPattern>::reinit;
   };
 
-  /*@}*/
+  /** @} */
 
 } /* namespace TrilinosWrappers */
 
index 9ed2a22492379bbba7f7fb758c73a50583120b63..3a55071a3a6ee9f2789f3296da419a932f3c0993 100644 (file)
@@ -46,8 +46,9 @@ namespace TrilinosWrappers
 #endif
 
 
-/*! @addtogroup Vectors
- *@{
+/**
+ * @addtogroup Vectors
+ * @{
  */
 
 
@@ -364,10 +365,10 @@ public:
    * Exception
    */
   DeclException0(ExcIteratorRangeDoesNotMatchVectorSize);
-  //@}
+  /** @} */
 };
 
-/*@}*/
+/** @} */
 
 #ifndef DOXYGEN
 /*----------------------- Inline functions ----------------------------------*/
index 51cfe5765fd1bed42ce5eeaa95847c17de025c91..636babfe39e7582f4b79d89a8e389f6291bc47d5 100644 (file)
@@ -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 ----------------------------------*/
 
index c517beae89016322de137aa758541368fd1965d8..ff74a410e39efd312abe8968d18930abf2ed5a70 100644 (file)
@@ -40,8 +40,9 @@ template <typename number>
 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>i,j</i>) to <tt>value</tt>. Throws an error if the
    * entry does not exist or if <tt>value</tt> is not a finite number. Still,
@@ -804,11 +805,11 @@ public:
   void
   add(const number factor, const ChunkSparseMatrix<somenumber> &matrix);
 
-  //@}
+  /** @} */
   /**
    * @name Entry Access
    */
-  //@{
+  /** @{ */
 
   /**
    * Return the value of the entry (<i>i,j</i>).  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 <i>dst = M*src</i> with <i>M</i> being
    * this matrix.
@@ -987,11 +988,11 @@ public:
            const Vector<somenumber> &x,
            const Vector<somenumber> &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<somenumber> &      v,
             const Vector<somenumber> &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 <tt>(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 -----------------------------------*/
index cf93766b8fbee768624414d5173eb0bbb4a50e05..3a45a7b3b16afa73c94ac50fb372a48b56fae473 100644 (file)
@@ -36,8 +36,9 @@ template <typename>
 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
index 6013cec72dc4ce8635d602aa5ef7aff661c0f10f..f8beaf9c051519b83ea6ea78dede5fa73db502dd 100644 (file)
@@ -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
 
index ff7c325eaedf0a2a819b70d263e9c62d203cc315..98e7ae00b5023d47822a3cd49e2848471409d4e5 100644 (file)
@@ -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<Number> &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<Number> &      dst,
              const LinearAlgebra::CUDAWrappers::Vector<Number> &x,
              const LinearAlgebra::CUDAWrappers::Vector<Number> &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<Number *, int *, int *, cusparseMatDescr_t, cusparseSpMatDescr_t>
     get_cusparse_matrix() const;
-    //@}
+    /** @} */
 
   private:
     /**
index 1269af680556458661d3fd63aa11f98a18943456..031e48f8e2e78426b373872dbbec2b9bd4f18677 100644 (file)
@@ -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 -----------------------------------*/
 
 
index 672f995f572bdebf12e8d9c2f604c319647f63d8..c7775f1592274c61dc74628f183be9db39bc33e6 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-/*!@addtogroup Solvers */
-/*@{*/
+/**
+ * @addtogroup Solvers
+ * @{
+ */
 
 /**
  * Power method (von Mises) for eigenvalue computations.
@@ -186,7 +188,7 @@ protected:
   AdditionalData additional_data;
 };
 
-/*@}*/
+/** @} */
 //---------------------------------------------------------------------------
 
 
index c1f89f4184790fe9b1e01c5eeeef4cb05551d344..cb66b3d3a32d909f684e578b6784399634074ff1 100644 (file)
@@ -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
 
 
index 2d8357228cd64a6248b8322833ab0e7bc2748c93..be214bdfecfcb6561ab08b9bc65924e13d46e97e 100644 (file)
@@ -43,8 +43,9 @@ template <typename number>
 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 <tt>r</tt>.
@@ -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<number2> &M);
 
-  //@}
+  /** @} */
   ///@name Multiplications
-  //@{
+  /** @{ */
 
   /**
    * Matrix-matrix-multiplication.
@@ -1066,7 +1067,7 @@ public:
   void
   backward(Vector<number2> &dst, const Vector<number2> &src) const;
 
-  //@}
+  /** @} */
 
   /**
    * @addtogroup Exceptions
@@ -1107,7 +1108,7 @@ public:
    * Exception
    */
   DeclException0(ExcMatrixNotPositiveDefinite);
-  //@}
+  /** @} */
 };
 
 /**@}*/
index 28da6232f32dc95532e499ccafce90586cc17560..f063f56292fcc4cdcd8bec36a9a7b369062d6393 100644 (file)
@@ -34,8 +34,9 @@ template <typename number>
 class Vector;
 #endif
 
-/*! @addtogroup Matrix2
- *@{
+/**
+ * @addtogroup Matrix2
+ * @{
  */
 
 
@@ -156,7 +157,7 @@ private:
   FullMatrix<double> storage;
 };
 
-/*@}*/
+/** @} */
 
 #ifndef DOXYGEN
 /*-------------------------Inline functions -------------------------------*/
index 80e588e2d143b7e8d262b49ef4fcd7387f5e5105..6b4fbd628d2ca34c6d1b74142d0c4395c8f556ac 100644 (file)
@@ -23,8 +23,9 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-/*! @addtogroup Matrix1
- *@{
+/**
+ * @addtogroup Matrix1
+ * @{
  */
 
 
index 33970cfedf637503fa5a8b90b45a6d515b5c3ab9..2f1b00e8514b7088ed6dd2f96dfa778d327925ca 100644 (file)
@@ -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<Number> &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
 
index a2bdced59abf733a2fd91053e391eb91b057c55d..adbd4f5ae09a03b944b5c78bd14978866a00d677 100644 (file)
@@ -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<Number, MemorySpace> &
       operator=(const Vector<Number2, MemorySpace> &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<Number, MemorySpace2> &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<Number, MemorySpace> &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<ArrayView<const Number>> &
       shared_vector_data() const;
 
-      //@}
+      /** @} */
 
       /**
        * Attempt to perform an operation between two incompatible vector types.
@@ -1431,7 +1432,7 @@ namespace LinearAlgebra
       template <typename Number2>
       friend class BlockVector;
     };
-    /*@}*/
+    /** @} */
 
 
     /*-------------------- Inline functions ---------------------------------*/
index 008c95734de8e055f3b854ae81258500c82c8bc0..a865fdbaa5b21c4152128de7d200f1fe9d43d6ac 100644 (file)
@@ -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 <typename Number>
index 321724d44322c24486bd96752c3068a7845dd3c2..9bec900bbb6366dd6bd20d67fce490fc90281e64 100644 (file)
@@ -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<Range, Domain, Payload> &op,
   return number * op;
 }
 
-//@}
+/** @} */
 
 
 /**
  * @name Composition and manipulation of a LinearOperator
  */
-//@{
+/** @{ */
 
 /**
  * @relatesalso LinearOperator
@@ -840,13 +840,13 @@ inverse_operator(const LinearOperator<Range, Domain, Payload> &op,
   return inverse_operator(op, solver);
 }
 
-//@}
+/** @} */
 
 
 /**
  * @name Creation of a LinearOperator
  */
-//@{
+/** @{ */
 
 /**
  * @relatesalso LinearOperator
@@ -1477,7 +1477,7 @@ linear_operator(const LinearOperator<Range, Domain, Payload> &operator_exemplar,
 }
 
 
-//@}
+/** @} */
 
 #ifndef DOXYGEN
 
index 13a86bb1d1565129a1e6f0241a8cdac60c628c9d..1226ea093457c09095422a24d34b9dde61f7bc5b 100644 (file)
@@ -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<Range> &comp)
   return PackagedOperation<Range>(offset) - comp;
 }
 
-//@}
+/** @} */
 
 
 /**
  * @name Creation of a PackagedOperation object
  */
-//@{
+/** @{ */
 
 namespace internal
 {
@@ -805,7 +805,7 @@ operator*(const PackagedOperation<Range> &              comp,
   return return_comp;
 }
 
-//@}
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index dc49dd1c2105592eb0e0ad7d8cc583d10b45ee74..913a694b87c69b99d20703ca39317f8b7286ac7b 100644 (file)
@@ -37,8 +37,9 @@ namespace PETScWrappers
 {
   namespace MPI
   {
-    /*! @addtogroup PETScWrappers
-     *@{
+    /**
+     * @addtogroup PETScWrappers
+     * @{
      */
 
     /**
@@ -274,7 +275,7 @@ namespace PETScWrappers
 
 
 
-    /*@}*/
+    /** @} */
 
     // ------------- inline and template functions -----------------
 
index afebbff4852fc12af75b90308903356b7ce77281..97c80245a6b251e4df35a59cc8805033d596d867 100644 (file)
@@ -37,8 +37,9 @@ namespace PETScWrappers
 
   namespace MPI
   {
-    /*! @addtogroup PETScWrappers
-     *@{
+    /**
+     * @addtogroup PETScWrappers
+     * @{
      */
 
     /**
@@ -285,7 +286,7 @@ namespace PETScWrappers
       DeclException0(ExcNonMatchingBlockVectors);
     };
 
-    /*@}*/
+    /** @} */
 
     /*--------------------- Inline functions --------------------------------*/
 
index 5ad7fe227023c7c1db11b19884010e4792896b5e..05e5d68c0fd9dd692c1100d88f2ebb735d29275a 100644 (file)
@@ -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
 
 
index 152efc294c3cdd498a89c34f6d0f7063b41e80d3..edfeb9b3aebb3a86be8269d9e87ede4714ae60bf 100644 (file)
@@ -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
index bfcfb92179fbce9959a64935e9c800c5a28dbefd..7f4e2a10c797a94ef1675ba521565d67b0ee39d2 100644 (file)
@@ -34,8 +34,9 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-/*! @addtogroup PETScWrappers
- *@{
+/**
+ * @addtogroup PETScWrappers
+ * @{
  */
 namespace PETScWrappers
 {
index f52fb172467b46cd2bb37307cef313007d86e15b..035c86afc81375b82d8e054bc8c1622d6ef24f20 100644 (file)
@@ -54,8 +54,9 @@ namespace LinearAlgebra
 #endif
 
 
-/*! @addtogroup Preconditioners
- *@{
+/**
+ * @addtogroup Preconditioners
+ * @{
  */
 
 
@@ -1879,7 +1880,7 @@ private:
 
 
 
-/*@}*/
+/** @} */
 /* ---------------------------------- Inline functions ------------------- */
 
 #ifndef DOXYGEN
index 2ee41e9ded56470c9e069b33e9609f3fbaed5d1b..ea90fa9209ee5454f041034d514155dff10a75dc 100644 (file)
@@ -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<number2> &dst, const Vector<number2> &rhs) const;
 };
 
-/*@}*/
+/** @} */
 //---------------------------------------------------------------------------
 
 #ifndef DOXYGEN
index 06026aa17db9c310698e20ea8733c8d925451d56..31849f39fd68f6b37e7d3cd13bc5d61a99d9c179 100644 (file)
@@ -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 ------------------- */
 
 
index 9ac4e5c3112fe6ae2af1a589f784a02e781b1086..9a915f0f5bb11a66a22e0450abd8c58d583527a4 100644 (file)
@@ -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 ---------------------------*/
index c3228cca84e2624ae62cf0278065341db4ba8e4b..187a11e6349e47c5cd29927e9a1a14650475d55a 100644 (file)
@@ -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<Domain_1, Range_1, Payload> &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
 
index 27397bcda900c25d693e234f6dbba1818cb5ae7f..8dc901a874a1baaf8fbdae0908b1c329b6e590ae 100644 (file)
 
 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
index 5aa2d1d3380ad318d9fb0f2182253ac97f17b8e2..63902fd915fa89f61984eeaf2b4fa5d33fe90b26 100644 (file)
@@ -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 ----------------------------*/
 
index 2a15485ea9e282be4dcc3f54130cf270508deae5..45508e12d5fcba85063b6f2edca4516cee220a59 100644 (file)
@@ -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
index 01bda880bf896b18312442aad4dbccdd87c1c826..35f0f7131f6cd5264f962214eed565f46e0c7850 100644 (file)
 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 ----------------------------*/
 
index d2eda60e636f26c118f456f95b8f3dd62445b422..3b4e3f19ed0afce14e226456f30a06235361737e 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup Solvers */
-/*@{*/
+/**
+ * @addtogroup Solvers
+ * @{
+ */
 
 namespace internal
 {
@@ -519,7 +521,7 @@ private:
   FullMatrix<double> H1;
 };
 
-/*@}*/
+/** @} */
 /* --------------------- Inline and template functions ------------------- */
 
 
index 1e0f963660c4ae6f21ca7760f376db4831ad91e0..64bc3c679343af144bcf249784d6e9a32cbddbd1 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup Solvers */
-/*@{*/
+/**
+ * @addtogroup Solvers
+ * @{
+ */
 
 namespace internal
 {
@@ -180,7 +182,7 @@ private:
   AdditionalData additional_data;
 };
 
-/*@}*/
+/** @} */
 /*------------------------- Implementation ----------------------------*/
 
 #ifndef DOXYGEN
index 999e2a077d56e0e3603f9a957307158fd0a4f108..a78bfa29c93ade9a9241fd0a150c04714270192c 100644 (file)
 
 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
index 9d5dd4aec512698be03f43d18ffa710aea09bf37..6e1677c0a179fbd184d9afb411ab1904c77592c8 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup Solvers */
-/*@{*/
+/**
+ * @addtogroup Solvers
+ * @{
+ */
 
 /**
  * <h3>Quasi-minimal method for symmetric matrices (SQMR)</h3>
@@ -232,7 +234,7 @@ private:
   unsigned int step;
 };
 
-/*@}*/
+/** @} */
 /*------------------------- Implementation ----------------------------*/
 
 #ifndef DOXYGEN
index d65ee66f63114b15a34f0bfd4336f91ad40126be..7edc8bc873eb3943d41d01c330c9aca797b4083e 100644 (file)
 
 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
index 36b646165b485bc3c562bd59628f7422861147c7..d2f2adb423dfc038313c453bd9861f47ea93fdf3 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-/*!@addtogroup Solvers */
-/*@{*/
+/**
+ * @addtogroup Solvers
+ * @{
+ */
 
 /**
  * Selects a solver by changing a parameter.
@@ -240,7 +242,7 @@ private:
   typename SolverFGMRES<VectorType>::AdditionalData fgmres_data;
 };
 
-/*@}*/
+/** @} */
 /* --------------------- Inline and template functions ------------------- */
 
 
index 506acd30c58c064e2c6492e865ede81237c6b9bc..6f472d60dc9f62df8435a60be9b50df22eda218e 100644 (file)
@@ -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
index 5d07ecbca3f3f91e642eb81827ab65b514732b20..485877a32c7243be4e2f23760a41c89257985062 100644 (file)
@@ -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.");
-  //@}
+  /** @} */
 };
 
-/*@}*/
+/** @} */
 //---------------------------------------------------------------------------
 
 
index e110831ef2a4a789c5a076d49ee0bedff00ffb66..f3c71bd7ff798f6673c4b7d245752e970ee1dce8 100644 (file)
@@ -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>i,j</i>) to <tt>value</tt>. Throws an error if the
    * entry does not exist or if <tt>value</tt> is not a finite number. Still,
@@ -1050,11 +1050,11 @@ public:
   void
   add(const number factor, const SparseMatrix<somenumber> &matrix);
 
-  //@}
+  /** @} */
   /**
    * @name Accessing elements
    */
-  //@{
+  /** @{ */
 
   /**
    * Return the value of the entry (<i>i,j</i>).  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 <i>dst = M*src</i> with <i>M</i> being
    * this matrix.
@@ -1314,11 +1314,11 @@ public:
          const Vector<number> &       V = Vector<number>(),
          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<somenumber> &      v,
             const Vector<somenumber> &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 <tt>(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:
   /**
index 2a1ef600b45472d1920f1cb01a2f8dadbc83ebfa..f854c21fa42d36dadd0d23536b1cf5b8399a217b 100644 (file)
@@ -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<size_type> &used_by_line,
                      const bool              compute_by_line) const;
-  //@}
+  /** @} */
   /**
    * @name Modifying entries
    */
-  //@{
+  /** @{ */
   /**
    * Set the element <tt>(i,j)</tt> to @p value.
    *
@@ -575,11 +575,11 @@ public:
   template <typename MatrixType>
   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 <typename somenumber>
   void
   Tvmult_add(Vector<somenumber> &dst, const Vector<somenumber> &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 <tt>(line,col)
    * value</tt>, 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
index ac8bc882a8ebd3fee7578526e13bf8f46f12b30f..8c3ba26fc7ea7c46340d3558f8a5775359ba4f68 100644 (file)
@@ -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
 
index 6e72f8c29118fd37b6ee3e0c2355e3adb3c9f54f..74157ec9c93ef98d70f6b28d12fbdb3b3b33519b 100644 (file)
@@ -43,8 +43,9 @@ template <typename number>
 class SparseBlockVanka;
 #endif
 
-/*! @addtogroup Preconditioners
- *@{
+/**
+ * @addtogroup Preconditioners
+ * @{
  */
 
 /**
@@ -544,7 +545,7 @@ private:
                     const BlockingStrategy      blocking_strategy);
 };
 
-/*@}*/
+/** @} */
 /* ---------------------------------- Inline functions ------------------- */
 
 #ifndef DOXYGEN
index 399ec6097895c3522c827ca7aba89e98b68e0195..65d10340846791f67f880a144ed2980ab0e77f78 100644 (file)
@@ -62,8 +62,9 @@ namespace ChunkSparsityPatternIterators
 }
 #endif
 
-/*! @addtogroup Sparsity
- *@{
+/**
+ * @addtogroup Sparsity
+ * @{
  */
 
 namespace internals
index e845eb5f6291ff0eaf1ed0e9980bf1df354f46be..cfcf74bc044646255cf116fdc223816b80d0cac3 100644 (file)
@@ -37,8 +37,9 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-/*! @addtogroup Sparsity
- *@{
+/**
+ * @addtogroup Sparsity
+ * @{
  */
 
 /**
index c7966ec51477c09ef60534bf7836db03f50d816a..4d03298637c99cf3de69071fee2fcb922d2ccf83 100644 (file)
@@ -33,8 +33,9 @@ template <typename number>
 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 <i>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>|i-j| <= 1</i>.
@@ -125,10 +126,10 @@ public:
   number &
   operator()(size_type i, size_type j);
 
-  //@}
+  /** @} */
 
   ///@name Multiplications with vectors
-  //@{
+  /** @{ */
 
   /**
    * Matrix-vector-multiplication. Multiplies <tt>v</tt> from the right and
@@ -197,10 +198,10 @@ public:
   number
   matrix_norm_square(const Vector<number> &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:
   /**
index 5890f7fa0058505e28b21cbeafc61be314e2cc80..8bb38cbb9b1b8710758fbcdd2c04d70b6a5e66f9 100644 (file)
@@ -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 -----------------
 
index d559bc37da3403aaeaea0247519980fbf3001824..fd42cb50b6ff3e145de11b8e86f72cc3dee5dfd3 100644 (file)
@@ -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<m, Range, Domain, BlockPayload>(ops);
   }
 
-  //@}
+  /** @} */
 
 } // namespace TrilinosWrappers
 
index 4c22ebfa56f5cc592ca0f7929cfabbf81fcbfbaf..3d32bbbd9de965d9208734d10592ef973bf48d44 100644 (file)
@@ -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
index 0050877869d47d62d883f93275ad2b90e73632c5..85819e6e6b6b6aa8404c8e453ed2d3b5394ae773 100644 (file)
@@ -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
index cdea737e408c4c575412c4458760e0575764afc2..3f8c6f669e9ce6f7fa3225a81b1e67dec3e6347b 100644 (file)
@@ -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>i,j</i>).  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 <i>dst = M*src</i> with <i>M</i>
@@ -1617,11 +1617,11 @@ namespace TrilinosWrappers
            const SparseMatrix &B,
            const MPI::Vector & V = MPI::Vector()) const;
 
-    //@}
+    /** @} */
     /**
      * @name Matrix norms
      */
-    //@{
+    /** @{ */
 
     /**
      * Return the <i>l</i><sub>1</sub>-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<void(VectorType &, const VectorType &)> 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:
         /**
index 38ffa5097f755814136864994551d98b29323169..aa417bd35ecd16ffdb75d5828b5a2fc8ab605a34 100644 (file)
@@ -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>i,j</i>) 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
index 7bf5c3ed4f6d8e0bd9c1605f65e7d745b138c766..cd2f45619cbe86bd4f54ce46242be0744860673f 100644 (file)
@@ -414,7 +414,7 @@ namespace TrilinosWrappers
       /**
        * @name 1: Basic Object-handling
        */
-      //@{
+      /** @{ */
       /**
        * Default constructor that generates an empty (zero size) vector. The
        * function <tt>reinit()</tt> 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
index b031633fb1e40bbe12b859bf5de2e57e1ecf04c4..ee7cfbb37bb891446a2e4606fad846d21fe4d3b0 100644 (file)
@@ -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<Number2> &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<Number> &V, const Vector<Number> &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<Number>::load(Archive &ar, const unsigned int)
 #endif
 
 
-/*! @addtogroup Vectors
- *@{
+/**
+ * @addtogroup Vectors
+ * @{
  */
 
 
@@ -1429,7 +1431,7 @@ operator<<(std::ostream &out, const Vector<number> &v)
   return out;
 }
 
-/*@}*/
+/** @} */
 
 
 /**
index 9775ca0854b1fc734b30f70a84722169673c9789..a397bd2668ea287829b77ba93610941ca9711b45 100644 (file)
 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 ---------------------- */
index 5867ce99216330895e1d1b2454c0e0f957aa3e6f..d73a01655cc1953429ed3af10d0bf154bdf349a7 100644 (file)
@@ -20,8 +20,9 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-/*! @addtogroup Vectors
- *@{
+/**
+ * @addtogroup Vectors
+ * @{
  */
 
 /**
@@ -62,7 +63,7 @@ struct VectorOperation
   };
 };
 
-/*@}*/
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index 8817eb6ec36f9cfa6aad46ff6cab10cae825ca73..78fc64822ad6450de9a488b5f2a218e00237e585 100644 (file)
@@ -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 --------------------------
index 16a639c76b0891f2cd3c7bf36a8a341083e028bf..8f8b82ab8014916dadcf5c303737b622945771c2 100644 (file)
@@ -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<VectorizedArrayType::size()> &mask =
       std::bitset<VectorizedArrayType::size()>().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.
index da9d22100abc85a1f4edebc018fe67dea7c90dd8..f6854fb0c6786cd15d76c63b4937d78447397356 100644 (file)
@@ -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<unsigned int, unsigned int>
   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<std::array<T, Number::size()>> &array,
                 const std::array<T, Number::size()> &         value) const;
 
-  //@}
+  /** @} */
 
   /**
    * This data structure is used for the initialization by the derived
index 55113dbb6e115b177eb1c721ac2b0b61a9fc9d84..6717becfb6319e61745a609cbf5a0685d928c8d6 100644 (file)
@@ -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<unsigned int, unsigned int> 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<types::global_dof_index> &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<Number> *memory) const;
 
-  //@}
+  /** @} */
 
 private:
   /**
index 15d2c7188af68e585666edb733d3d44fa87a4745..98fedd0e207798d3899f4e0f62e8513a92b0b140 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup MeshWorker */
-/*@{*/
+/**
+ * @addtogroup MeshWorker
+ * @{
+ */
 
 namespace MeshWorker
 {
@@ -195,7 +197,7 @@ namespace MeshWorker
   }
 } // namespace MeshWorker
 
-/*@}*/
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index 438c90c3f28de4b32c5b1ab5c9ebe08b18c0c949..d27b4518f9ff95c30d3c2e703b8dc71ef5e4819f 100644 (file)
@@ -466,7 +466,7 @@ namespace MeshWorker
      * The quadrature rule used on interior faces.
      */
     Quadrature<dim - 1> face_quadrature;
-    /* @} */
+    /** @} */
 
     /**
      * @name Data vectors
@@ -503,7 +503,7 @@ namespace MeshWorker
     std::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim>> cell_data;
     std::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim>> boundary_data;
     std::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim>> face_data;
-    /* @} */
+    /** @} */
 
     /**
      * @name Interface for MeshWorker::loop()
@@ -572,7 +572,7 @@ namespace MeshWorker
      */
     CellInfo neighbor;
 
-    /* @} */
+    /** @} */
   };
 
 
index 9f401b85502878a5b314519447b7b6b7f23d1905..5e6299bf136a876867b7e283f5ac0630de857ea9 100644 (file)
@@ -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
index 2a9aacfea46f0f02000e27983eda0a687b03db63..5324b1fb443003d8dd7926315ebad09c5d0094d0 100644 (file)
 
 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
 
index 97a12a6570cbfa57923109c4fa4b87fc7c20ab62..f29c0dddd3efb3cb3a0471c4b5ec4baeb7ba979e 100644 (file)
@@ -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
index bb0e327d6bb1f7b3d774cb69b461b9526f2dbf31..aefc1b4689308c73ae6f4cfeed2e372d2fba0e18 100644 (file)
 
 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<number> matrix;
 };
 
-/*@}*/
+/** @} */
 
 #ifndef DOXYGEN
 /* ------------------ Functions for MGCoarseGridApplySmoother -----------*/
index 7831c9086332ddb6b0acff663d15506c91985271..dbf15d45b82d2f3015ccf39684e1ae0f706cf223 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-/*!@addtogroup mg */
-/*@{*/
+/**
+ * @addtogroup mg
+ * @{
+ */
 
 namespace mg
 {
@@ -191,7 +193,7 @@ private:
   unsigned int col;
 };
 
-/*@}*/
+/** @} */
 
 /*----------------------------------------------------------------------*/
 
index 1afe47c81c098d188267076020b46daecae9f451..b805774a02b383c4db6e1aa4a28898add8ac38cf 100644 (file)
@@ -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<LinearOperator<VectorType>> matrices;
 };
 
-/*@}*/
+/** @} */
 
 /* ------------------------------- Inline functions --------------------------
  */
index ab8ff63317b67ba266573d67dfa5767adf53f365..b0c7af8b74f12721d45c58ed6841ced74843cb72 100644 (file)
@@ -397,7 +397,7 @@ namespace MGTools
 
 } // namespace MGTools
 
-/* @} */
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index 44adaf68ee74de5eddf5b42d0f3380a71af34736..5927dfb3716ba164731cc5a062b2bc4bb714d3f3 100644 (file)
@@ -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
index 45ed5112617c351fd3de405f91125e07726ab3c0..16843b1caf2c17fd81ff4ddb25826e944ae295f7 100644 (file)
@@ -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 <typename number>
index fbb9c060b310e805d00649e0447855cf8f7c8ea1..0f82d52fec7eacd3d55e310448847bf7d62b05e4 100644 (file)
@@ -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<const AffineConstraints<double>> constraints;
 };
 
-/*@}*/
+/** @} */
 
 //---------------------------------------------------------------------------
 template <typename number>
index d49ab0a1fd8e645de9d41bbe28b827fbb3e574bf..af0f3ff9f32a8d4d70b960e886e55d265afea86f 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-/*!@addtogroup mg */
-/*@{*/
+/**
+ * @addtogroup mg
+ * @{
+ */
 
 /**
  * Implementation of the MGTransferBase interface for which the transfer
@@ -539,7 +541,7 @@ private:
 };
 
 
-/*@}*/
+/** @} */
 
 
 //------------------------ templated functions -------------------------
index 23a6b6d18f37ee592cd1038e440c266cc4610668..34d4306660b2cbc92fbe80ca29b0bd0bfafe8d9e 100644 (file)
@@ -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 --------------------- */
index 0d139e1b25ee38cb923888c29fd4e1454ab27955..52bead1a934449c53237c9eddb64a888c89d516c 100644 (file)
@@ -44,7 +44,7 @@ namespace VectorTools
   /**
    * @name Interpolation and projection
    */
-  //@{
+  /** @{ */
 
   /**
    * Compute constraints on the solution that corresponds to the imposition
index 0371942424b22dc6a00cbbe9a52c9f4205666172..5b3aa88d08b8cdc15ca539c4e7c3f37f5a584f7d 100644 (file)
@@ -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
index 9afd7c161734f5a0042cf3a303a02d998e86a60d..247123c1864422d10e8888a7a12c0009ef7c203a 100644 (file)
@@ -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
index c0c00718fb063c3bfb5db664aba58b79458ceccf..490d6af7bedc90e21cfd0bd639aa32c1655aac4b 100644 (file)
@@ -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<typename VectorType::value_type> &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
index b5923d9013cae0541344993500bab10abf79ee29..b2e5ddee2e9e037b39c44caaed6f2889f2430dd9 100644 (file)
@@ -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<dim> &          quadrature,
                      const VectorType &               v,
                      const unsigned int               component);
-  //@}
+  /** @} */
 } // namespace VectorTools
 
 DEAL_II_NAMESPACE_CLOSE
index 208f618c364d16ee3df5c340c1f64680d9d34dfc..76489a74e40bcf6e59d3b11d596dc8085f941d56 100644 (file)
@@ -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<spacedim, double> &             point);
 
-  //@}
+  /** @} */
 } // namespace VectorTools
 
 DEAL_II_NAMESPACE_CLOSE
index 3129da0c61abae33deb93b9356dd13cb64e966cf..0c1bd99b5994b77e2be9fdf9987b88b12a29a724 100644 (file)
@@ -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<dim, spacedim> &           dof,
               const VectorType &                          fe_function,
               const Point<spacedim, double> &             point);
-  //@}
+  /** @} */
 } // namespace VectorTools
 
 DEAL_II_NAMESPACE_CLOSE
index 4f635c43a65235d1fc9669c543dee9a79f2bedd8..0600e0ebbee752bd6e6bf7af59da767f552187a7 100644 (file)
@@ -54,7 +54,7 @@ namespace VectorTools
   /**
    * @name Interpolation and projection
    */
-  //@{
+  /** @{ */
 
   /**
    * Compute the projection of @p function to the finite element space. In other
index 8e160ef940eb495587782d86a6199cd64f62ed89..60d20134e145c23fee5354c6bf34d23435fc1d34 100644 (file)
@@ -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
index 244a13f908bd373ba5e9772605a02dc41eb29d37..bffda1334b5f13e005c766021e86837325192fba 100644 (file)
@@ -418,7 +418,7 @@ namespace OpenCASCADE
 
 } // namespace OpenCASCADE
 
-/*@}*/
+/** @} */
 
 DEAL_II_NAMESPACE_CLOSE
 
index f9fdd505604816a971438918801242afac6e9cff..1b0ab70d38456b8e0c0f79137a5c460710aae4b1 100644 (file)
@@ -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
index 20ec58220d5258d42d198a9cf0361a319b3cf714..306f7cd42fca89d3e717cd0244d9b9cfd087414b 100644 (file)
@@ -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
index 43b70278014c1366d4f419e92778d1d018cede95..28d09f74b3f7b6edfed49249d90400498307ec4c 100644 (file)
@@ -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<Number>
       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 <typename TensorType, typename Number>
       TensorType
       to_tensor(const FullMatrix<Number> &vec);
-      //@}
+      /** @} */
 
     } // namespace Kelvin
 
index 1472980482e6ed70dfc81899a705ec815096f60a..14ef674d63b9332a209beccc27c83ac8e89eabe6 100644 (file)
@@ -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

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.