From a60a529b44d723c8629bfcd9dbcb64b0c74503e3 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Fri, 8 May 2020 12:03:26 -0400 Subject: [PATCH] release step 0c: doxygen formatting Nothing major, just putting @ref and
on separate lines. Everything else looks good. --- include/deal.II/base/mpi.h | 10 ++++++---- include/deal.II/base/types.h | 8 ++++++-- include/deal.II/distributed/tria_base.h | 18 ++++++++++++------ include/deal.II/fe/fe_nedelec_sz.h | 2 +- include/deal.II/grid/cell_id.h | 3 ++- include/deal.II/grid/tria.h | 8 ++++++-- include/deal.II/grid/tria_description.h | 3 ++- include/deal.II/hp/refinement.h | 9 ++++++--- .../numerics/vector_tools_interpolate.h | 3 ++- 9 files changed, 43 insertions(+), 21 deletions(-) diff --git a/include/deal.II/base/mpi.h b/include/deal.II/base/mpi.h index 58dd3a4881..d261fb9244 100644 --- a/include/deal.II/base/mpi.h +++ b/include/deal.II/base/mpi.h @@ -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. * diff --git a/include/deal.II/base/types.h b/include/deal.II/base/types.h index 586d09194b..c313003950 100644 --- a/include/deal.II/base/types.h +++ b/include/deal.II/base/types.h @@ -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(-1); diff --git a/include/deal.II/distributed/tria_base.h b/include/deal.II/distributed/tria_base.h index 87c93a8540..ba4a8e9763 100644 --- a/include/deal.II/distributed/tria_base.h +++ b/include/deal.II/distributed/tria_base.h @@ -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 diff --git a/include/deal.II/fe/fe_nedelec_sz.h b/include/deal.II/fe/fe_nedelec_sz.h index 93a279e0b3..6ddec53bd7 100644 --- a/include/deal.II/fe/fe_nedelec_sz.h +++ b/include/deal.II/fe/fe_nedelec_sz.h @@ -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 diff --git a/include/deal.II/grid/cell_id.h b/include/deal.II/grid/cell_id.h index f628f0b920..666816da2b 100644 --- a/include/deal.II/grid/cell_id.h +++ b/include/deal.II/grid/cell_id.h @@ -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 diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index e6e56432cf..1db6fd4a28 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -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(). diff --git a/include/deal.II/grid/tria_description.h b/include/deal.II/grid/tria_description.h index b0a10f1375..1d8a43d7a1 100644 --- a/include/deal.II/grid/tria_description.h +++ b/include/deal.II/grid/tria_description.h @@ -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 coarse_cell_index_to_coarse_cell_id; diff --git a/include/deal.II/hp/refinement.h b/include/deal.II/hp/refinement.h index dbfdc705d3..0109518351 100644 --- a/include/deal.II/hp/refinement.h +++ b/include/deal.II/hp/refinement.h @@ -583,14 +583,17 @@ namespace hp * all siblings together how they will be coarsened. We distinguish between * three different cases: *
    - *
  1. Not all siblings flagged for coarsening: p-coarsening
    + *
  2. Not all siblings flagged for coarsening: p-coarsening. + *
    * We keep the @p future_fe_indices and clear the coarsen flags * on all siblings. *
  3. All siblings flagged for coarsening, but not all for - * p-adaptation: h-coarsening
    + * p-adaptation: h-coarsening. + *
    * We keep the coarsen flags and clear all @p future_fe_indices * on all siblings. - *
  4. All siblings flagged for coarsening and p-adaptation: p-coarsening
    + *
  5. All siblings flagged for coarsening and p-adaptation: p-coarsening. + *
    * We keep the @p future_fe_indices and clear the coarsen flags * on all siblings. *
diff --git a/include/deal.II/numerics/vector_tools_interpolate.h b/include/deal.II/numerics/vector_tools_interpolate.h index a916bdfb73..d628a29d92 100644 --- a/include/deal.II/numerics/vector_tools_interpolate.h +++ b/include/deal.II/numerics/vector_tools_interpolate.h @@ -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. -- 2.39.5