]> https://gitweb.dealii.org/ - dealii.git/commitdiff
release step 0c: doxygen formatting 10094/head
authorTimo Heister <timo.heister@gmail.com>
Fri, 8 May 2020 16:03:26 +0000 (12:03 -0400)
committerTimo Heister <timo.heister@gmail.com>
Fri, 8 May 2020 16:03:26 +0000 (12:03 -0400)
Nothing major, just putting @ref and <br> on separate lines. Everything
else looks good.

include/deal.II/base/mpi.h
include/deal.II/base/types.h
include/deal.II/distributed/tria_base.h
include/deal.II/fe/fe_nedelec_sz.h
include/deal.II/grid/cell_id.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_description.h
include/deal.II/hp/refinement.h
include/deal.II/numerics/vector_tools_interpolate.h

index 58dd3a488142cdefafb043ddfc72e19200233e51..d261fb924447246f9ffae6755c0e9b3dae412e73 100644 (file)
@@ -751,8 +751,9 @@ namespace Utilities
     /**
      * Same as above but returning the sum, average, minimum, maximum,
      * process id of minimum and maximum as a collective operation on the
-     * given MPI @ref GlossMPICommunicator "communicator" @p mpi_communicator
-     * for each entry of the vector.
+     * given MPI
+     * @ref GlossMPICommunicator "communicator"
+     * @p mpi_communicator for each entry of the vector.
      *
      * @note This function performs a single reduction sweep.
      *
@@ -766,8 +767,9 @@ namespace Utilities
     /**
      * Same as above but returning the sum, average, minimum, maximum,
      * process id of minimum and maximum as a collective operation on the
-     * given MPI @ref GlossMPICommunicator "communicator" @p mpi_communicator
-     * for each entry of the ArrayView.
+     * given MPI
+     * @ref GlossMPICommunicator "communicator"
+     * @p mpi_communicator for each entry of the ArrayView.
      *
      * @note This function performs a single reduction sweep.
      *
index 586d09194bfc61a01ab35027b857ba21b41b9be9..c31300395030a463a8105789c26e7397cdd60df4 100644 (file)
@@ -107,7 +107,9 @@ namespace types
 
   /**
    * The type used for coarse-cell ids. See the glossary
-   * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+   * entry on
+   * @ref GlossCoarseCellId "coarse cell IDs"
+   * for more information.
    */
   using coarse_cell_id = global_cell_index;
 
@@ -206,7 +208,9 @@ namespace numbers
 
   /**
    * An invalid value for coarse cell ids. See the glossary
-   * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+   * entry on
+   * @ref GlossCoarseCellId "coarse cell IDs"
+   * for more information.
    */
   const types::coarse_cell_id invalid_coarse_cell_id =
     static_cast<types::coarse_cell_id>(-1);
index 87c93a85408cea1a03ae7ac5635027fbdd44d1da..ba4a8e9763d65a5b7e58bf5e288404b15d0e623f 100644 (file)
@@ -62,11 +62,13 @@ namespace parallel
    * @endcode
    *
    * All parallel triangulations share certain traits, such as the fact that
-   * they communicate via @ref GlossMPICommunicator "MPI communicators" or
-   * that they have
+   * they communicate via
+   * @ref GlossMPICommunicator "MPI communicators"
+   * or that they have
    * @ref GlossLocallyOwnedCell "locally owned",
    * @ref GlossGhostCell "ghost", and possibly
-   * @ref GlossArtificialCell "artificial cells". This class provides
+   * @ref GlossArtificialCell "artificial cells".
+   * This class provides
    * a number of member functions that allows querying some information
    * about the triangulation that is independent of how exactly a
    * parallel triangulation is implemented (i.e., which of the various
@@ -307,9 +309,13 @@ namespace parallel
    * every detail of a triangulation may be known on each processor.
    * In particular, you have to expect that triangulations of classes
    * derived from this one only store some of the active cells (namely,
-   * the @ref GlossLocallyOwnedCell "locally owned cells"), along
-   * with @ref GlossGhostCell "ghost cells" and possibly
-   * @ref GlossArtificialCell "artificial cells". In contrast to the classes
+   * the
+   * @ref GlossLocallyOwnedCell "locally owned cells"),
+   * along with
+   * @ref GlossGhostCell "ghost cells"
+   * and possibly
+   * @ref GlossArtificialCell "artificial cells".
+   * In contrast to the classes
    * derived from parallel::TriangulationBase, it is certain that the
    * classes derived from the current class will not store the entire
    * triangulation as long as it has a large enough number of cells. (The
index 93a279e0b3338842f7ae5fd4d7f162140d9bd170..6ddec53bd7200735a835c36ae87df90ea8c9d891 100644 (file)
@@ -83,7 +83,7 @@ public:
    * Constructor for the NedelecSZ element of given @p order. The maximal
    * polynomial degree of the shape functions is `order+1` (in each variable;
    * the total polynomial degree may be higher). If `order = 0`, the element is
-   * linear and has degrees of freedom only on the edges. If `order >=1` the
+   * linear and has degrees of freedom only on the edges. If `order >= 1` the
    * element has degrees of freedom on the edges, faces and volume. For example
    * 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
index f628f0b92035670d6dc3202a0da71adbe0b39098..666816da2b06e06993fdfc7814dfd21696b2f1db 100644 (file)
@@ -44,7 +44,8 @@ class Triangulation;
  *
  * This class stores the index of the coarse cell from which a cell is
  * descendant (or, more specifically, the
- * entry on @ref GlossCoarseCellId "coarse cell IDs"),
+ * entry on
+ * @ref GlossCoarseCellId "coarse cell IDs"),
  * together with information on how to reach the cell from that coarse cell
  * (i.e., which child index to take on each level of the triangulation when
  * moving from one cell to its children). The important point about this
index e6e56432cf38e1936023e842383d32a9feb54687..1db6fd4a28f6ef11c4d04ed5f30024a068e0841c 100644 (file)
@@ -3793,7 +3793,9 @@ private:
 
   /**
    * Translate the unique id of a coarse cell to its index. See the glossary
-   * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+   * entry on
+   * @ref GlossCoarseCellId "coarse cell IDs"
+   * for more information.
    *
    * @note For serial and shared triangulation both id and index are the same.
    *       For distributed triangulations setting both might differ, since the
@@ -3809,7 +3811,9 @@ private:
 
   /**
    * Translate the index of coarse cell to its unique id. See the glossary
-   * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+   * entry on
+   * @ref GlossCoarseCellId "coarse cell IDs"
+   * for more information.
    *
    * @note See the note of the method
    * coarse_cell_id_to_coarse_cell_index().
index b0a10f137551433e77703994f788e51db1e83c99..1d8a43d7a1cb1d17982249d6537655bd12cc475c 100644 (file)
@@ -371,7 +371,8 @@ namespace TriangulationDescription
 
     /**
      * List that for each locally-relevant coarse cell provides the
-     * corresponding global @ref GlossCoarseCellId.
+     * corresponding global
+     * @ref GlossCoarseCellId.
      */
     std::vector<types::coarse_cell_id> coarse_cell_index_to_coarse_cell_id;
 
index dbfdc705d3686320b9a7c19fe9004303df0c4c28..0109518351f421fba262e1487e996f505ca92d9a 100644 (file)
@@ -583,14 +583,17 @@ namespace hp
      * all siblings together how they will be coarsened. We distinguish between
      * three different cases:
      * <ol>
-     * <li> Not all siblings flagged for coarsening: p-coarsening<br>
+     * <li> Not all siblings flagged for coarsening: p-coarsening.
+     *   <br>
      *   We keep the @p future_fe_indices and clear the coarsen flags
      *   on all siblings.
      * <li> All siblings flagged for coarsening, but not all for
-     *   p-adaptation: h-coarsening<br>
+     *   p-adaptation: h-coarsening.
+     *   <br>
      *   We keep the coarsen flags and clear all @p future_fe_indices
      *   on all siblings.
-     * <li> All siblings flagged for coarsening and p-adaptation: p-coarsening<br>
+     * <li> All siblings flagged for coarsening and p-adaptation: p-coarsening.
+     *   <br>
      *   We keep the @p future_fe_indices and clear the coarsen flags
      *   on all siblings.
      * </ol>
index a916bdfb739c48f864bc93b437ff719a72e48a10..d628a29d92bc0c67df12083a280150983af49367 100644 (file)
@@ -92,7 +92,8 @@ namespace VectorTools
 
   /**
    * Interpolate different finite element spaces. The interpolation of vector
-   * @p data_1 (which is assumed to be ghosted, see @ref GlossGhostedVector)
+   * @p data_1 (which is assumed to be ghosted, see
+   * @ref GlossGhostedVector)
    * is executed from the FE space represented by @p dof_1
    * to the vector @p data_2 on FE space @p dof_2.
    * The interpolation on each cell is represented by the matrix @p transfer.

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.