]> https://gitweb.dealii.org/ - dealii.git/commitdiff
some doxygen formatting fixes 13836/head
authorTimo Heister <timo.heister@gmail.com>
Fri, 27 May 2022 15:47:18 +0000 (11:47 -0400)
committerTimo Heister <timo.heister@gmail.com>
Fri, 27 May 2022 21:40:19 +0000 (17:40 -0400)
- consistent indentation of comments
- put @ref on separate line
- some minor fixes

(this is done with wrapcomments.py and checking things manually)

32 files changed:
include/deal.II/algorithms/timestep_control.h
include/deal.II/arborx/access_traits.h
include/deal.II/base/data_out_base.h
include/deal.II/base/discrete_time.h
include/deal.II/base/function.h
include/deal.II/base/hdf5.h
include/deal.II/base/vectorization.h
include/deal.II/distributed/tria_base.h
include/deal.II/dofs/dof_accessor.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_raviart_thomas.h
include/deal.II/fe/fe_simplex_p_bubbles.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_out.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/reference_cell.h
include/deal.II/hp/collection.h
include/deal.II/lac/cuda_precondition.h
include/deal.II/lac/cuda_sparse_matrix.h
include/deal.II/lac/precondition.h
include/deal.II/lac/scalapack.templates.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/matrix_free/cuda_matrix_free.h
include/deal.II/matrix_free/cuda_tensor_product_kernels.h
include/deal.II/matrix_free/fe_point_evaluation.h
include/deal.II/non_matching/immersed_surface_quadrature.h
include/deal.II/numerics/data_out.h
include/deal.II/physics/elasticity/kinematics.h

index 9b56654bc8fd99f1cccc93ef2485cf30b294803b..4e0205538c421a61464c3fc184ac9406b49200f4 100644 (file)
@@ -174,7 +174,7 @@ namespace Algorithms
     double start_val;
 
     /**
-     *The end of the time interval.
+     * The end of the time interval.
      */
     double final_val;
 
index b1269fc5d47c2b4786a0e95145bf060e09fcd05f..646915bbeaf556a314e60d24b49fce5f244d6908 100644 (file)
@@ -245,10 +245,10 @@ namespace ArborXWrappers
 
 
   /**
-   *  This class defines a predicate used by ArborXWrappers::BVH to determine
-   *  for given spheres which of the bounding boxes used to build the
-   *  ArborXWrappers::BVH intersect with them.
-   *  @note The class is not supposed to be used in a polymorphic context.
+   * This class defines a predicate used by ArborXWrappers::BVH to determine
+   * for given spheres which of the bounding boxes used to build the
+   * ArborXWrappers::BVH intersect with them.
+   * @note The class is not supposed to be used in a polymorphic context.
    */
   class SphereIntersectPredicate : private SpherePredicate
   {
index c0b7ad769b6d91d91b1a988c0d1b41ae556c7a64..dc35266b27f4a4af668e6f0f755f0b921ec59109 100644 (file)
@@ -702,7 +702,7 @@ namespace DataOutBase
   {
     /**
      * Default constructor. Sets up the dimension labels with the default values
-     of <tt>"x"</tt>, <tt>"y"</tt>, and <tt>"z"</tt>.
+     of <tt>"x"</tt>, <tt>"y"</tt>, and <tt>"z"</tt>.
      */
     GnuplotFlags();
 
@@ -1536,7 +1536,8 @@ namespace DataOutBase
     unsigned int node_dim;
 
     /**
-     * The number of cells stored in @ref filtered_cells.
+     * The number of cells stored in
+     * @ref filtered_cells.
      */
     unsigned int num_cells;
 
index a7e61840dda7cfa44f63c4e42b2d931c2d4f192f..18890921c2c31aa8c16cb4987e370dca57853095 100644 (file)
@@ -401,7 +401,7 @@ private:
   double start_time;
 
   /**
-   *The end of the time interval.
+   * The end of the time interval.
    */
   double end_time;
 
index f5005ff8fe9eaf6a46f1b03c0b59991ae52bc9af..7f25ba2ea764f09526313e8908016947f81ce544 100644 (file)
@@ -774,7 +774,8 @@ protected:
  * component, and consequently is not shown in boldface. Then assume
  * that we want this $u_h(x)$ to be used as a boundary condition for a 2d
  * problem at the line $y=0$. Let's say that this line corresponds to
- * @ref GlossBoundaryIndicator "boundary indicator" 123.
+ * @ref GlossBoundaryIndicator "boundary indicator"
+ * 123.
  * If we say that the 2d problem is associated with
  * @code
  *   DoFHandler<2> dof_handler_2d;
index ec2c1aa5ddc468650a9c6f08b724c36e105f714c..f556eba1b8db671c3358484d57d7487e0b5d27bd 100644 (file)
@@ -1122,7 +1122,8 @@ namespace HDF5
 
   namespace internal
   {
-    /** This function returns the HDF5 datatype corresponding to the C++ type.
+    /**
+     * This function returns the HDF5 datatype corresponding to the C++ type.
      * In the case of std::complex types the HDF5 handlers are automatically
      * freed using the destructor of `std::shared_ptr`. `std::shared_ptr` is
      * used instead of `std::unique_ptr` because the destructor of
@@ -1136,7 +1137,8 @@ namespace HDF5
     std::shared_ptr<hid_t>
     get_hdf5_datatype();
 
-    /** Return the dimensions of `data`. For a std::vector this function returns
+    /**
+     * Return the dimensions of `data`. For a std::vector this function returns
      * `std::vector<hsize_t>{vector_size}`.
      *
      * Several HDF5 functions such as H5Screate_simple() require a
@@ -1148,42 +1150,48 @@ namespace HDF5
     std::vector<hsize_t>
     get_container_dimensions(const std::vector<number> &data);
 
-    /** Return the dimensions of `data`. For a Vector this function returns
+    /**
+     * Return the dimensions of `data`. For a Vector this function returns
      * `std::vector<hsize_t>{vector_size}`.
      */
     template <typename number>
     std::vector<hsize_t>
     get_container_dimensions(const Vector<number> &data);
 
-    /** Return the dimensions of `data`. For a FullMatrix the function returns
+    /**
+     * Return the dimensions of `data`. For a FullMatrix the function returns
      * `std::vector<hsize_t>{rows, columns}`.
      */
     template <typename number>
     std::vector<hsize_t>
     get_container_dimensions(const FullMatrix<number> &data);
 
-    /** This function returns the total size of the container. For a std::vector
+    /**
+     * This function returns the total size of the container. For a std::vector
      * the function returns `int(vector_size)`.
      */
     template <typename number>
     unsigned int
     get_container_size(const std::vector<number> &data);
 
-    /** This function returns the total size of the container. For a Vector the
+    /**
+     * This function returns the total size of the container. For a Vector the
      * function returns `int(vector_size)`.
      */
     template <typename number>
     unsigned int
     get_container_size(const Vector<number> &data);
 
-    /** This function returns the total size of the container. For a FullMatrix
+    /**
+     * This function returns the total size of the container. For a FullMatrix
      * the function returns `int(rows*columns)`.
      */
     template <typename number>
     unsigned int
     get_container_size(const FullMatrix<number> &data);
 
-    /** This function initializes and returns a container of type std::vector,
+    /**
+     * This function initializes and returns a container of type std::vector,
      * Vector or FullMatrix. The function does not set the values of the
      * elements of the container. The container can store data of a HDF5 dataset
      * or a HDF5 selection. The dimensions parameter holds the dimensions of the
@@ -1207,7 +1215,8 @@ namespace HDF5
       Container>::type
     initialize_container(const std::vector<hsize_t> &dimensions);
 
-    /** Same as above.
+    /**
+     * Same as above.
      */
     template <typename Container>
     typename std::enable_if<
@@ -1215,7 +1224,8 @@ namespace HDF5
       Container>::type
     initialize_container(const std::vector<hsize_t> &dimensions);
 
-    /** Same as above.
+    /**
+     * Same as above.
      */
     template <typename Container>
     typename std::enable_if<
@@ -1224,7 +1234,8 @@ namespace HDF5
       Container>::type
     initialize_container(const std::vector<hsize_t> &dimensions);
 
-    /** This helper function sets the property list of the read and write
+    /**
+     * This helper function sets the property list of the read and write
      * operations of DataSet. A property list has to be created for the MPI
      * driver. For the serial driver the default H5P_DEFAULT can be used. In
      * addition H5Pset_dxpl_mpio is used to set the MPI mode to collective.
@@ -1232,7 +1243,8 @@ namespace HDF5
     inline void
     set_plist(hid_t &plist, const bool mpi);
 
-    /** This helper function releases the property list handler of the read and
+    /**
+     * This helper function releases the property list handler of the read and
      * write operations of DataSet. For the serial version there is no need to
      * release the property list handler because H5P_DEFAULT has been used. If
      * query_io_mode is True then H5Pget_mpio_actual_io_mode and
@@ -1247,7 +1259,8 @@ namespace HDF5
                   const bool                 mpi,
                   const bool                 query_io_mode);
 
-    /** Convert a HDF5 no_collective_cause code to a human readable string.
+    /**
+     * Convert a HDF5 no_collective_cause code to a human readable string.
      */
     inline std::string
     no_collective_cause_to_string(const uint32_t no_collective_cause);
index 720e29e885312d6927a32fd5046351a933179468..7f61b5ec8a105238ec7a775c2baaf939dfc27b25 100644 (file)
@@ -756,7 +756,7 @@ inline DEAL_II_ALWAYS_INLINE VectorizedArray<Number, width>
  * Create a vectorized array of given type and broadcast the scalar value
  * to all array elements.
  *
- *  @relatesalso VectorizedArray
+ * @relatesalso VectorizedArray
  */
 template <typename VectorizedArrayType>
 inline DEAL_II_ALWAYS_INLINE VectorizedArrayType
@@ -1111,7 +1111,8 @@ public:
     _mm512_storeu_pd(ptr, data);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    * @note Memory must be aligned by 64 bytes.
    */
   DEAL_II_ALWAYS_INLINE
@@ -1668,7 +1669,8 @@ public:
     _mm512_storeu_ps(ptr, data);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    * @note Memory must be aligned by 64 bytes.
    */
   DEAL_II_ALWAYS_INLINE
@@ -2321,7 +2323,8 @@ public:
     _mm256_storeu_pd(ptr, data);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    * @note Memory must be aligned by 32 bytes.
    */
   DEAL_II_ALWAYS_INLINE
@@ -2837,7 +2840,8 @@ public:
     _mm256_storeu_ps(ptr, data);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    * @note Memory must be aligned by 32 bytes.
    */
   DEAL_II_ALWAYS_INLINE
@@ -3383,7 +3387,8 @@ public:
     _mm_storeu_pd(ptr, data);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    * @note Memory must be aligned by 16 bytes.
    */
   DEAL_II_ALWAYS_INLINE
@@ -3830,7 +3835,8 @@ public:
     _mm_storeu_ps(ptr, data);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    * @note Memory must be aligned by 16 bytes.
    */
   DEAL_II_ALWAYS_INLINE
@@ -4299,7 +4305,8 @@ public:
     vec_vsx_st(data, 0, ptr);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    */
   DEAL_II_ALWAYS_INLINE
   void
@@ -4308,7 +4315,8 @@ public:
     store(ptr);
   }
 
-  /** @copydoc VectorizedArray<Number>::gather()
+  /**
+   * @copydoc VectorizedArray<Number>::gather()
    */
   DEAL_II_ALWAYS_INLINE
   void
@@ -4318,7 +4326,8 @@ public:
       *(reinterpret_cast<double *>(&data) + i) = base_ptr[offsets[i]];
   }
 
-  /** @copydoc VectorizedArray<Number>::scatter
+  /**
+   * @copydoc VectorizedArray<Number>::scatter
    */
   DEAL_II_ALWAYS_INLINE
   void
@@ -4543,7 +4552,8 @@ public:
     vec_vsx_st(data, 0, ptr);
   }
 
-  /** @copydoc VectorizedArray<Number>::streaming_store()
+  /**
+   * @copydoc VectorizedArray<Number>::streaming_store()
    */
   DEAL_II_ALWAYS_INLINE
   void
@@ -4552,7 +4562,8 @@ public:
     store(ptr);
   }
 
-  /** @copydoc VectorizedArray<Number>::gather()
+  /**
+   * @copydoc VectorizedArray<Number>::gather()
    */
   DEAL_II_ALWAYS_INLINE
   void
@@ -4562,7 +4573,8 @@ public:
       *(reinterpret_cast<float *>(&data) + i) = base_ptr[offsets[i]];
   }
 
-  /** @copydoc VectorizedArray<Number>::scatter
+  /**
+   * @copydoc VectorizedArray<Number>::scatter
    */
   DEAL_II_ALWAYS_INLINE
   void
index 67052755e3d011d92b5c80aa148b1b396390f90d..1decdad82bda6d297e5146e94242d5859dea289e 100644 (file)
@@ -66,7 +66,8 @@ namespace parallel
    * @ref GlossMPICommunicator "MPI communicators"
    * or that they have
    * @ref GlossLocallyOwnedCell "locally owned",
-   * @ref GlossGhostCell "ghost", and possibly
+   * @ref GlossGhostCell "ghost",
+   * and possibly
    * @ref GlossArtificialCell "artificial cells".
    * This class provides
    * a number of member functions that allows querying some information
@@ -685,7 +686,8 @@ namespace parallel
      * Save additional cell-attached data into the given file. The first
      * arguments are used to determine the offsets where to write buffers to.
      *
-     * Called by @ref save.
+     * Called by
+     * @ref save.
      */
     void
     save_attached_data(const unsigned int global_first_cell,
@@ -697,7 +699,8 @@ namespace parallel
      * The first arguments are used to determine the offsets where to read
      * buffers from.
      *
-     * Called by @ref load.
+     * Called by
+     * @ref load.
      */
     void
     load_attached_data(const unsigned int global_first_cell,
index 74f4f3f163f715b2d9f3e9d99cc47524e76f5187..5a600c8ba226b734367016e8f35950bfecc21957 100644 (file)
@@ -140,7 +140,8 @@ namespace internal
  * A class that gives access to the degrees of freedom stored in a DoFHandler
  * object. Accessors are used to access the data that pertains to edges,
  * faces, and cells of a triangulation. The concept is explained in more
- * detail in connection to @ref Iterators.
+ * detail in connection to
+ * @ref Iterators.
  *
  * This class follows mainly the route laid out by the accessor library
  * declared in the triangulation library (TriaAccessor). It enables the user
index b213950aae40cb73816284442d3a703744e96b94..3616755787e690975bdc8798074ca0ccd4b82602 100644 (file)
@@ -47,7 +47,7 @@ namespace FEInterfaceViews
   public:
     /**
      * The constructor.
-     **/
+     */
     Base(const FEInterfaceValues<dim, spacedim> &fe_interface);
 
   protected:
index d39627d3b47f35bfef3fdb5d6834dc26dd487603..396b8d040601a95b6c49f0736dab285c8bae6e9d 100644 (file)
@@ -66,13 +66,15 @@ DEAL_II_NAMESPACE_OPEN
  * field must be continuous across the line (or surface) even though
  * the normal component may not be. As a consequence, the
  * N&eacute;d&eacute;lec element is constructed in such a way that (i) it is
- * @ref vector_valued "vector-valued", (ii) the shape functions are
+ * @ref vector_valued "vector-valued",
+ * (ii) the shape functions are
  * discontinuous, but (iii) the tangential component(s) of the vector field
  * represented by each shape function are continuous across the faces
  * of cells.
  *
  * Other properties of the N&eacute;d&eacute;lec element are that (i) it is
- * @ref GlossPrimitive "not a primitive element"; (ii) the shape functions
+ * @ref GlossPrimitive "not a primitive element"
+ * ; (ii) the shape functions
  * are defined so that certain integrals over the faces are either zero
  * or one, rather than the common case of certain point values being
  * either zero or one.
@@ -406,7 +408,9 @@ public:
    * the 3D version of FE_Nedelec has 12 degrees of freedom for `order = 0`
    * and 54 for `degree = 1`. It is important to have enough quadrature points
    * in order to perform the quadrature with sufficient accuracy.
-   * For example [QGauss<dim>(order + 2)](@ref QGauss) can be used for the
+   * For example
+   * [QGauss<dim>(order + 2)](@ref QGauss)
+   * can be used for the
    * quadrature formula, where `order` is the order of FE_Nedelec.
    */
   FE_Nedelec(const unsigned int order);
index adc53214d0df369fbe2394124d26046c9fac01af..a77a547a82dc2bd19c916494ae9cdeec4bc8ff08 100644 (file)
@@ -85,7 +85,9 @@ public:
    * the 3D version of FE_NedelecSZ has 12 degrees of freedom for `order = 0`
    * and 54 for `degree = 1`. It is important to have enough quadrature points
    * in order to perform the quadrature with sufficient accuracy.
-   * For example [QGauss<dim>(order + 2)](@ref QGauss) can be used for the
+   * For example
+   * [QGauss<dim>(order + 2)](@ref QGauss)
+   * can be used for the
    * quadrature formula, where `order` is the order of FE_NedelecSZ.
    */
   FE_NedelecSZ(const unsigned int order);
index aba6b1a3743ab10389875df5a3cc4e58f48c2add..98ebdc76dac2431c51631fe173b3a00f4da954ed 100644 (file)
@@ -47,13 +47,15 @@ DEAL_II_NAMESPACE_OPEN
  * field must be continuous across the line (or surface) even though
  * the tangential component may not be. As a consequence, the
  * Raviart-Thomas element is constructed in such a way that (i) it is
- * @ref vector_valued "vector-valued", (ii) the shape functions are
+ * @ref vector_valued "vector-valued",
+ * (ii) the shape functions are
  * discontinuous, but (iii) the normal component of the vector field
  * represented by each shape function is continuous across the faces
  * of cells.
  *
  * Other properties of the Raviart-Thomas element are that (i) it is
- * @ref GlossPrimitive "not a primitive element"; (ii) the shape functions
+ * @ref GlossPrimitive "not a primitive element"
+ * ; (ii) the shape functions
  * are defined so that certain integrals over the faces are either zero
  * or one, rather than the common case of certain point values being
  * either zero or one. (There is, however, the FE_RaviartThomasNodal
@@ -219,8 +221,8 @@ private:
    * <code>adjust_quad_dof_index_for_face_orientation_table</code> declared in
    * fe.cc. We need to fill it with the correct values in case of non-standard,
    * flipped (rotated by +180 degrees) or rotated (rotated by +90 degrees)
-   *faces. These are given in the form three flags (face_orientation, face_flip,
-   * face_rotation), see the documentation in GeometryInfo<dim> and
+   * faces. These are given in the form three flags (face_orientation,
+   * face_flip, face_rotation), see the documentation in GeometryInfo<dim> and
    * this @ref GlossFaceOrientation "glossary entry on face orientation".
    *
    * <h3>Example: Raviart-Thomas Elements of order 2 (tensor polynomial
index 8b556fcfc2cc6f2ed98b6206dfe9ef481d66eb0b..8a19ed11af9be63c6173c9d1a88ffc3aee18d4d8 100644 (file)
@@ -43,7 +43,7 @@ DEAL_II_NAMESPACE_OPEN
  * unstable approximation to the mass matrix. For example: the shape functions
  * of FE_SimplexP<2>(2) with support points at vertices have mean values of
  * zero so that element cannot be used with mass lumping.
-
+ *
  * This element avoids this issue by replacing the shape functions of
  * FE_SimplexP with an augmented space amenable to the construction of nodal
  * quadrature rules. For example, on the triangle a single basis function is
index c46c62f2997c62011c95196f91fef1056210803d..f8d2b0b9f6df7fbf2a1de2acc10e9cf8c8e526e2 100644 (file)
@@ -907,8 +907,10 @@ namespace FETools
    * <li> Tensor product construction (<code>do_tensor_product=true</code>):
    * The tensor product construction, in the simplest case, builds a
    * vector-valued element from scalar elements (see
-   * @ref vector_valued "this documentation module" and
-   * @ref GlossComponent "this glossary entry" for more information).
+   * @ref vector_valued "this documentation module"
+   * and
+   * @ref GlossComponent "this glossary entry"
+   * for more information).
    * To give an example, consider creating a vector-valued element with
    * two vector components, where the first should have linear shape
    * functions and the second quadratic shape functions. In 1d, the
index ed3a1b9c964f7046ca377dacddcc5a9a388b385c..974dc2ce009fcd6a93820572e35abf8805f88d5a 100644 (file)
@@ -91,7 +91,7 @@ namespace FETools
 
     private:
       /**
-       *  A shortcut for the type of the OutVector.
+       * A shortcut for the type of the OutVector.
        */
       using value_type = typename OutVector::value_type;
 
index bd9fd57c64c45f03693c4f2010adeacf2eea4100..d93d88e0eccb93a2dac03c5ca453511684026e5c 100644 (file)
@@ -375,7 +375,7 @@ namespace GridGenerator
    *
    * In 3D, triangulation will be extruded in the z-direction by the total
    * height of @p L using @p n_slices slices (minimum is 2).
-
+   *
    * If the @p colorize flag is <code>true</code>, the boundary_ids of the
    * boundary faces are assigned such that the lower one in the x-direction is
    * 0, and the upper one is 1 (see
@@ -385,7 +385,7 @@ namespace GridGenerator
    *
    * @p tria is the triangulation to be created. It needs to be empty upon
    * calling this function.
-*/
+   */
   template <int dim>
   void
   plate_with_a_hole(Triangulation<dim> &     tria,
@@ -1050,7 +1050,8 @@ namespace GridGenerator
    * opening to match their index. All other boundary faces will be assigned
    * boundary ID 3.
    *
-   * @ref GlossManifoldIndicator "Manifold IDs" will be set on the mantles of each truncated cone in
+   * @ref GlossManifoldIndicator "Manifold IDs"
+   * will be set on the mantles of each truncated cone in
    * the same way. Each cone will have a special manifold object assigned, which
    * is based on the CylindricalManifold class. Further, all cells adjacent to
    * the mantle are given the manifold ID 3. If desired, you can assign an
@@ -1202,8 +1203,8 @@ namespace GridGenerator
    * If the @p colorize flag is <code>true</code>, the @p boundary_ids of the
    * surfaces are assigned such that the left boundary is 0 and the others are
    * assigned counterclockwise in ascending order (see
-   * @ref GlossColorization "the glossary entry on colorization"). The @p
-   * colorize option only works in two dimensions.
+   * @ref GlossColorization "the glossary entry on colorization").
+   * The @p colorize option only works in two dimensions.
    *
    * This function will create the classical L-shape in 2d
    * and it will look like the following in 3d:
@@ -1762,7 +1763,8 @@ namespace GridGenerator
    * This function is most often used to compose meshes for more complicated
    * geometries if the geometry can be composed of simpler parts for which
    * functions exist to generate
-   * @ref GlossCoarseMesh "coarse meshes". For example, the channel mesh
+   * @ref GlossCoarseMesh "coarse meshes".
+   * For example, the channel mesh
    * used in step-35 could in principle be created using a mesh created by the
    * GridGenerator::hyper_cube_with_cylindrical_hole function and several
    * rectangles, and merging them using the current function. The rectangles
@@ -1796,7 +1798,8 @@ namespace GridGenerator
    * the input meshes.
    *
    * @note The two input triangulations must be
-   * @ref GlossCoarseMesh "coarse meshes", i.e., they can not have any
+   * @ref GlossCoarseMesh "coarse meshes",
+   * i.e., they can not have any
    * refined cells.
    *
    * @note The function copies the material ids of the cells of the two input
@@ -1906,7 +1909,8 @@ namespace GridGenerator
    * @note This function is intended to create an adaptively refined
    * triangulation that contains the <i>most refined cells</i> from two input
    * triangulations that were derived from the <i>same</i>
-   * @ref GlossCoarseMesh "coarse mesh" by
+   * @ref GlossCoarseMesh "coarse mesh"
+   * by
    * adaptive refinement. This is an operation sometimes needed when one
    * solves for two variables of a coupled problem on separately refined
    * meshes on the same domain (for example because these variables have
@@ -2122,8 +2126,10 @@ namespace GridGenerator
    * triangulation later on.
    *
    * All information about cell
-   * @ref GlossManifoldIndicator "manifold indicators" and
-   * @ref GlossMaterialId "material indicators" are copied from
+   * @ref GlossManifoldIndicator "manifold indicators"
+   * and
+   * @ref GlossMaterialId "material indicators"
+   * are copied from
    * one triangulation to the other. The same is true for the manifold
    * indicators and, if an object is at the boundary, the boundary
    * indicators of faces and edges of the triangulation.
index 7228bddc2d500e29306357535a93fb170a50c600..99410a3eed0695921869af46f42755a3e4e5adc7 100644 (file)
@@ -655,19 +655,19 @@ namespace GridOutFlags
   struct Svg
   {
     /**
-     *  Height of the plot in SVG units, computed from width if zero. Defaults
-     *  to 1000.
+     * Height of the plot in SVG units, computed from width if zero. Defaults
+     * to 1000.
      */
     unsigned int height;
 
     /**
-     *  The width of the plot. Computed automatically from height if zero
-     *  (default).
+     * The width of the plot. Computed automatically from height if zero
+     * (default).
      */
     unsigned int width;
 
     /**
-     *  Thickness of the lines between cells.
+     * Thickness of the lines between cells.
      */
     unsigned int line_thickness;
     /**
@@ -676,7 +676,7 @@ namespace GridOutFlags
     unsigned int boundary_line_thickness;
 
     /**
-     *  Margin around the plotted area.
+     * Margin around the plotted area.
      */
     bool margin;
 
index 028b41f0fed4ca4bdf5f94e6e14245b0d77aa75d..be23255d7535a7e7aa158025875e9a1959df434a 100644 (file)
@@ -495,7 +495,8 @@ namespace GridTools
    * vertices so that all lines are consistently oriented.
    *
    * The expectations on orientation and a discussion of this function are
-   * available in the @ref reordering "reordering module".
+   * available in the
+   * @ref reordering "reordering module".
    *
    * @param cells The array of CellData objects that describe the mesh's topology.
    */
index 76fdec26e449cdd0a484421e0d9c99b52ae4aa98..e27120347dca56c907fff81d417df1075ba002f4 100644 (file)
@@ -92,7 +92,8 @@ namespace internal
  * objects, and comparing against those special objects.
  *
  * The purposes and intents of this class are described in the
- * @ref GlossReferenceCell "reference cell" glossary entry.
+ * @ref GlossReferenceCell "reference cell"
+ * glossary entry.
  *
  * @ingroup grid geomprimitives aniso
  */
index 48e019e6629010fae75040db36f775a1084deb5e..6e8e89f2da2cf05dec9872a5c4ab742eea09b6a9 100644 (file)
@@ -170,7 +170,8 @@ namespace hp
   /**
    * This class implements a collection of objects.
    *
-   * It implements the concepts stated in the @ref hpcollection
+   * It implements the concepts stated in the
+   * @ref hpcollection
    * module described in the doxygen documentation.
    *
    * @ingroup hp hpcollection
index b55cfde2b9823af6f3d912a207ab1d83ef59e0c9..401bb2e31d79230753a5545afef3fc43a472ef50 100644 (file)
@@ -288,7 +288,7 @@ namespace CUDAWrappers
     {
       /**
        * Constructor. cuSPARSE allows to compute and use level information.
-       *  to the documentation this might improve performance.
+       * to the documentation this might improve performance.
        * It is suggested to try both options.
        */
       AdditionalData(bool use_level_analysis = true);
index b9da1aa51efbe616e6270001b44a5765ff8f5c9f..ff7c325eaedf0a2a819b70d263e9c62d203cc315 100644 (file)
@@ -315,7 +315,7 @@ namespace CUDAWrappers
     //@}
 
     /**
-     *@name Access to underlying CUDA data
+     * @name Access to underlying CUDA data
      */
     //@{
     /**
index fb4d54b67b52316f34ea372ae841ade189a737dc..ce6385cecc1691fb6756761940f7c6ce1cebbaa5 100644 (file)
@@ -1481,7 +1481,7 @@ public:
  * setting AdditionalData::eig_cg_n_iterations to zero, and provide the
  * variable AdditionalData::max_eigenvalue instead. The minimal eigenvalue is
  * implicitly specified via `max_eigenvalue/smoothing_range`.
-
+ *
  * <h4>Using the PreconditionChebyshev as a solver</h4>
  *
  * If the range <tt>[max_eigenvalue/smoothing_range, max_eigenvalue]</tt>
@@ -1637,7 +1637,7 @@ public:
                      EigenvalueAlgorithm::lanczos);
 
     /**
-     *  Copy assignment operator.
+     * Copy assignment operator.
      */
     AdditionalData &
     operator=(const AdditionalData &other_data);
index f29f1c7d560d8d9770d8d173133c76eada6e8f9a..df1eaec6839e23700d140cb197808fe8ce01ef95 100644 (file)
@@ -653,10 +653,10 @@ extern "C"
 
 
   /**
-   *  psyevx computes selected eigenvalues and, optionally, eigenvectors
-   *  of a real symmetric matrix A. Eigenvalues/vectors can be selected by
-   *  specifying a range of values or a range of indices for the desired
-   *  eigenvalues.
+   * psyevx computes selected eigenvalues and, optionally, eigenvectors
+   * of a real symmetric matrix A. Eigenvalues/vectors can be selected by
+   * specifying a range of values or a range of indices for the desired
+   * eigenvalues.
    */
   void
   pdsyevx_(const char *  jobz,
@@ -873,8 +873,8 @@ extern "C"
           const int *  DESCC);
 
   /**
-   *  psyevr computes selected eigenvalues and, optionally, eigenvectors
-   *  of a real symmetric matrix A using a parallel implementation of the MRR
+   * psyevr computes selected eigenvalues and, optionally, eigenvectors
+   * of a real symmetric matrix A using a parallel implementation of the MRR
    * algorithm. Eigenvalues/vectors can be selected by specifying a range of
    * values or a range of indices for the desired eigenvalues.
    */
index 90e794f5fa99d3b92e049e3f061a457128a7e5f8..7bf5c3ed4f6d8e0bd9c1605f65e7d745b138c766 100644 (file)
@@ -394,7 +394,6 @@ namespace TrilinosWrappers
      *
      * @ingroup TrilinosWrappers
      * @ingroup Vectors
-     *         2008, 2009, 2017
      */
     class Vector : public Subscriptor
     {
index efe64a5f9cc9020da957885e9c88e51dbddfbd14..b0a36ba45bed564c8320b19168b83ffbea006fae 100644 (file)
@@ -164,8 +164,8 @@ namespace CUDAWrappers
       bool use_coloring;
 
       /**
-       *  Overlap MPI communications with computation. This requires CUDA-aware
-       *  MPI and use_coloring must be false.
+       * Overlap MPI communications with computation. This requires CUDA-aware
+       * MPI and use_coloring must be false.
        */
       bool overlap_communication_computation;
     };
index 0ca73cd88c5802a00a3f81cce6f07fc4c33742ea..2d55db16e90e81fd0d8032f969f0a89d7b962ebb 100644 (file)
@@ -130,7 +130,7 @@ namespace CUDAWrappers
 
       /**
        * Evaluate the values and the gradients of the finite element function at
-       *  the quadrature points.
+       * the quadrature points.
        */
       __device__ void
       value_and_gradient_at_quad_pts(Number *const u, Number *grad_u[dim]);
index e1f7e5e474c6692e4699d1041cf62da6842205ab..bdc6b4bfd7b7c386672a362b766464cdc6c9451d 100644 (file)
@@ -435,8 +435,9 @@ namespace internal
  * avoids the memory allocation and other expensive start-up cost of
  * FEValues. Currently, the functionality is specialized for mappings derived
  * from MappingQ and MappingCartesian and for finite elements with tensor
- * product structure
- * that work with the @ref matrixfree module. In those cases, the cost implied
+ * product structure that work with the
+ * @ref matrixfree
+ * module. In those cases, the cost implied
  * by this class is similar (or sometimes even somewhat lower) than using
  * `FEValues::reinit(cell)` followed by `FEValues::get_function_gradients`.
  */
index 04860a737ca4ad6fd8be97e2e99218debc21107f..bc59656502c067e41d7c58a39ecbb0526a4def5f 100644 (file)
@@ -94,8 +94,8 @@ namespace NonMatching
    * can not be computed without knowing the surface normal in
    * $\mathbb{R}^{\text{spacedim}}$. The conormal is the unit vector parallel to
    * the projection of the face normal into the surface plane. This is
-   * essentially the same thing as the normalized @ref GlossBoundaryForm
-   * "boundary form".
+   * essentially the same thing as the normalized
+   * @ref GlossBoundaryForm "boundary form".
    */
   template <int dim, int spacedim = dim>
   class ImmersedSurfaceQuadrature : public Quadrature<dim>
index 0913e4c7403bbdeebf52537d63541ab7eab1d98e..bb754d60c43084251314dc9609fbd570b995c6e8 100644 (file)
@@ -118,7 +118,7 @@ namespace internal
  * small to be seen individually) or because you only want to see a certain
  * region of the domain (for example only in the fluid part of the domain in
  * step-46), or for some other reason.
-
+ *
  * For this, internally build_patches() does not generate the sequence of cells
  * to be converted into patches itself, but relies on the two private
  * std::function objects first_cell_function() and next_cell_function(). By
index 4e553d7c1fb1ec04a13f7d23f360d3085d72a283..f9fdd505604816a971438918801242afac6e9cff 100644 (file)
@@ -38,7 +38,7 @@ namespace Physics
      * Holzapfel (2007) and Wriggers (2008). The citation for these references,
      * as well as other notation used here, can be found in the description for
      * the Physics::Elasticity namespace.
-
+     *
      * @note These hold specifically for the codimension 0 case,
      * where the metric tensor is the identity tensor.
      */

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.