]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix doxygen @name tags
authorTimo Heister <timo.heister@gmail.com>
Thu, 16 May 2019 17:05:42 +0000 (11:05 -0600)
committerMatthias Maier <tamiko@43-1.org>
Thu, 16 May 2019 20:45:47 +0000 (15:45 -0500)
include/deal.II/base/point.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe_values.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/sparsity_pattern.h
include/deal.II/lac/tridiagonal_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/matrix_free/matrix_free.h

index 5faa10334004048936be94e2e672e5aa490997f8..11291018b52c20a6774bf81750e6d456387b6374 100644 (file)
@@ -176,7 +176,7 @@ public:
   Number &
   operator()(const unsigned int index);
 
-  /*
+  /**
    * @name Addition and subtraction of points.
    * @{
    */
@@ -216,7 +216,7 @@ public:
    * @}
    */
 
-  /*
+  /**
    * @name Multiplication and scaling of points. Dot products. Norms.
    * @{
    */
index e41edb9f639b9061fb5eae46b21645231f43ed14..ebf85ee84c057f40144c864a17ddcaaff603459c 100644 (file)
@@ -283,8 +283,10 @@ namespace DoFTools
    */
 
   /**
-   * @name Functions to support code that generically uses both DoFHandler and
-   * hp::DoFHandler
+   * @name Generic Functions
+   *
+   * Functions to support code that generically uses both DoFHandler and
+   * hp::DoFHandler.
    * @{
    */
   /**
index 040ef182adc98c234ff0e4ead8391455a047db0e..e93b0efbabb36e0700606aa2312a10f7c57e6fe4 100644 (file)
@@ -2138,8 +2138,9 @@ public:
   virtual ~FEValuesBase() override;
 
 
-  /// @name ShapeAccess Access to shape function values. These fields are filled
-  /// by the finite element.
+  /// @name ShapeAccess Access to shape function values
+  ///
+  /// These fields are filled by the finite element.
   //@{
 
   /**
@@ -2588,8 +2589,9 @@ public:
     bool quadrature_points_fastest = false) const;
 
   //@}
-  /// @name Access to second derivatives (Hessian matrices and Laplacians) of
-  /// global finite element fields
+  /// @name Access to second derivatives
+  ///
+  /// Hessian matrices and Laplacians of global finite element fields
   //@{
 
   /**
index 954168ded7954031b1ce6f1debde9694d4c7dfc7..a3210b3a69501ae91d2418b2a768d7a30732bd5a 100644 (file)
@@ -1520,8 +1520,9 @@ namespace GridGenerator
   ///@}
 
   /**
-   * @name Creating lower-dimensional meshes from parts of higher-dimensional
-   * meshes
+   * @name Creating lower-dimensional meshes
+   *
+   * Created from parts of higher-dimensional meshes.
    */
   ///@{
 
index 4a3473f57cf36e79d41d050fa32ea4f656bffe87..38d40ff9af157ca6aae1517ef7a60dd96d1a402a 100644 (file)
@@ -2147,8 +2147,10 @@ namespace GridTools
 
   /*@}*/
   /**
-   * @name Extracting and creating patches of cells surrounding a single cell,
-   * and creating triangulation out of them
+   * @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.
    */
   /*@{*/
 
index a3ff0d7384d7d7c7753bb27f6c223244ac4f7ab2..a37be90aa67f5c9267ab665180ac803b76c4d389 100644 (file)
@@ -420,7 +420,9 @@ public:
   bool
   operator>(const TriaRawIterator &) const;
 
-  /**@name Advancement of iterators*/
+  /**
+   * @name Advancement of iterators
+   */
   /*@{*/
   /**
    * Prefix <tt>++</tt> operator: <tt>++iterator</tt>. This operator advances
@@ -496,7 +498,9 @@ public:
   using pointer           = Accessor *;
   using reference         = Accessor &;
 
-  /**@name Exceptions*/
+  /**
+   * @name Exceptions
+   */
   /*@{*/
   /**
    * Exception for TriaObjects with level, i.e. cells.
@@ -684,7 +688,9 @@ public:
   TriaIterator<Accessor> &
   operator=(const TriaRawIterator<OtherAccessor> &);
 
-  /**@name Advancement of iterators*/
+  /**
+   * @name Advancement of iterators
+   */
   /*@{*/
   /**
    * Prefix <tt>++</tt> operator: <tt>++i</tt>. This operator advances the
@@ -891,7 +897,9 @@ public:
   TriaActiveIterator<Accessor> &
   operator++();
 
-  /**@name Advancement of iterators*/
+  /**
+   * @name Advancement of iterators
+   */
   /*@{*/
   /**
    * Postfix <tt>++</tt> operator: <tt>i++</tt>. This operator advances the
index 5af58738907893964f8c13a03e2ddaf08e58d870..b3ddd84ee3fe4f53545a3b5e7d61b539ba5ebdd3 100644 (file)
@@ -368,8 +368,10 @@ public:
   static const size_type invalid_entry = numbers::invalid_size_type;
 
   /**
-   * @name Construction and setup Constructors, destructor; functions
-   * initializing, copying and filling an object.
+   * @name Construction and Initialization
+   *
+   * Constructors, destructor, functions initializing, copying and filling an
+   * object.
    */
   // @{
   /**
@@ -885,8 +887,10 @@ public:
   using SparsityPatternBase::reinit;
 
   /**
-   * @name Construction and setup Constructors, destructor; functions
-   * initializing, copying and filling an object.
+   * @name Construction and setup
+   *
+   * Constructors, destructor, functions initializing, copying and filling an
+   * object.
    */
   // @{
   /**
index 9ccff0c068c1296e8556a3d8c9abd1d061194b41..5b92a38ecf0e0c10f403697c1d526c10d5ec1039 100644 (file)
@@ -60,7 +60,7 @@ public:
   using size_type = types::global_dof_index;
 
   /**
-   * @name Constructors and initialization.
+   * @name Constructors and initialization
    */
   /**
    * Constructor generating an empty matrix of dimension <tt>n</tt>.
index d0a985941020df75b7f1985c30521abb76a3f608..820af53d43ad664d6b2106d1170c6800cdd58895 100644 (file)
@@ -286,7 +286,7 @@ namespace TrilinosWrappers
     using const_iterator = SparsityPatternIterators::Iterator;
 
     /**
-     * @name Basic constructors and initialization.
+     * @name Basic constructors and initialization
      */
     //@{
     /**
index a2dd169c71acd2095fcfeb9fd07fd0cd9c6728b0..1216bcf231584267adfe57487cd6b7a0d19855c6 100644 (file)
@@ -1464,8 +1464,9 @@ public:
   //@}
 
   /**
-   * @name 5: Access of internal data structure (expert mode, interface not
-   * stable between releases)
+   * @name 5: Access of internal data structure
+   *
+   * Note: Expert mode, interface not stable between releases.
    */
   //@{
   /**

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.