From b1307f25182b334cf5bcbe4281ce35fcca1dc62d Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Tue, 24 Apr 2018 13:43:34 -0400 Subject: [PATCH] put @ref on separate lines --- include/deal.II/base/exceptions.h | 9 ++++++--- include/deal.II/base/mpi.h | 20 ++++++++++++++------ include/deal.II/distributed/shared_tria.h | 3 ++- include/deal.II/dofs/dof_accessor.h | 4 +++- include/deal.II/dofs/dof_renumbering.h | 11 ++++++++--- include/deal.II/fe/fe.h | 6 ++++-- include/deal.II/grid/grid_generator.h | 10 ++++++---- include/deal.II/grid/grid_in.h | 3 +-- include/deal.II/grid/tria.h | 7 ++++--- include/deal.II/hp/dof_handler.h | 3 ++- include/deal.II/lac/block_indices.h | 3 ++- include/deal.II/multigrid/multigrid.h | 3 ++- 12 files changed, 54 insertions(+), 28 deletions(-) diff --git a/include/deal.II/base/exceptions.h b/include/deal.II/base/exceptions.h index eba661a79d..9f03b13ab0 100644 --- a/include/deal.II/base/exceptions.h +++ b/include/deal.II/base/exceptions.h @@ -1100,7 +1100,8 @@ namespace deal_II_exceptions * error checking. It asserts that a certain condition is fulfilled, otherwise * issues an error and aborts the program. * - * A more detailed description can be found in the @ref Exceptions documentation + * A more detailed description can be found in the + * @ref Exceptions * module. It is first used in step-5 and step-6. * See also the ExceptionBase class for more information. * @@ -1141,7 +1142,8 @@ namespace deal_II_exceptions * the exception that would be thrown to deallog and continues normally * without throwing an exception. * - * A more detailed description can be found in the @ref Exceptions documentation + * A more detailed description can be found in the + * @ref Exceptions * module, in the discussion about the corner case at the bottom of the page. * * @note Active in DEBUG mode only @@ -1178,7 +1180,8 @@ namespace deal_II_exceptions * be caught via a @p catch clause, as is shown in step-6 and all following * tutorial programs. * - * A more detailed description can be found in the @ref Exceptions documentation + * A more detailed description can be found in the + * @ref Exceptions * module. It is first used in step-9 and step-13. * See also the ExceptionBase class for more information. * diff --git a/include/deal.II/base/mpi.h b/include/deal.II/base/mpi.h index 48e9ce5207..58e0878a39 100644 --- a/include/deal.II/base/mpi.h +++ b/include/deal.II/base/mpi.h @@ -316,8 +316,10 @@ namespace Utilities * A data structure to store the result of the min_max_avg() function. * The structure stores the minimum, maximum, and average of one * value contributed by each processor that participates in an - * @ref GlossMPICommunicator "MPI communicator". The structure also stores - * the indices (or, more precisely, the @ref GlossMPIRank "MPI rank") + * @ref GlossMPICommunicator "MPI communicator". + * The structure also stores + * the indices (or, more precisely, the + * @ref GlossMPIRank "MPI rank") * of the processors that hold the minimum and maximum values, * as well as the sum over all values. * @@ -345,15 +347,21 @@ namespace Utilities double max; /** - * One of the ranks (i.e., @ref GlossMPIRank "MPI rank" within an - * @ref GlossMPICommunicator "MPI communicator") of the + * One of the ranks (i.e., + * @ref GlossMPIRank "MPI rank" + * within an + * @ref GlossMPICommunicator "MPI communicator") + * of the * processors that hold the minimal value. */ unsigned int min_index; /** - * One of the ranks (i.e., @ref GlossMPIRank "MPI rank" within an - * @ref GlossMPICommunicator "MPI communicator") of the + * One of the ranks (i.e., + * @ref GlossMPIRank "MPI rank" + * within an + * @ref GlossMPICommunicator "MPI communicator") + * of the * processors that hold the maximal value. */ unsigned int max_index; diff --git a/include/deal.II/distributed/shared_tria.h b/include/deal.II/distributed/shared_tria.h index 0585cbaa05..062d05b796 100644 --- a/include/deal.II/distributed/shared_tria.h +++ b/include/deal.II/distributed/shared_tria.h @@ -151,7 +151,8 @@ namespace parallel * "Z-order" is also sometimes called "Morton ordering", see * https://en.wikipedia.org/wiki/Z-order_curve . * - * @see This @ref GlossZOrder "glossary entry". + * @see + * @ref GlossZOrder "Z order glossary entry". */ partition_zorder = 0x2, diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index d65c5c9d04..d2aa94eb96 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -1798,7 +1798,9 @@ public: * @note When using parallel meshes, either through the * parallel::shared::Triangulation or parallel::distributed::Triangulation * classes, it is only allowed to call this function on locally - * owned cells (see @ref GlossLocallyOwnedCell "this glossary entry"). This + * owned cells (see + * @ref GlossLocallyOwnedCell "this glossary entry"). + * This * is because otherwise a common source of errors would be if one * processor sets a different @p active_fe_index on a ghost cell than * the processor that actually owns the cell does. To avoid this mistake, diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index 458ebde1c7..18be08ea44 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -769,10 +769,13 @@ namespace DoFRenumbering * of cells is independent of the mesh's history, and so yields a * predictable DoF numbering. * - For meshes based on parallel::distributed::Triangulation, - * the @ref GlossLocallyOwnedCell "locally owned cells" of + * the + * @ref GlossLocallyOwnedCell "locally owned cells" + * of * each MPI process are contiguous in Z order. That means that * numbering degrees of freedom by visiting cells in Z order yields - * @ref GlossLocallyOwnedDof "locally owned DoF indices" that consist + * @ref GlossLocallyOwnedDof "locally owned DoF indices" + * that consist * of contiguous ranges for each process. This is also true for the * default ordering of DoFs on such triangulations, but the default * ordering creates an enumeration that also depends on how many @@ -786,7 +789,9 @@ namespace DoFRenumbering * a partitioning algorithm (selected by passing an object of type * parallel::shared::Triangulation::Settings to the constructor of the * triangulation), and in general these partitioning algorithms may - * assign cells to @ref GlossSubdomainId "subdomains" based on + * assign cells to + * @ref GlossSubdomainId "subdomains" + * based on * decisions that may have nothing to do with the Z order. (Though it * is possible to select these flags in a way so that partitioning * uses the Z order.) As a consequence, the cells of one subdomain diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 1e579bdc05..d9bdc43768 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -2138,7 +2138,8 @@ public: * support points of the reference cell, this function then computes what * the nodal values of the element are, i.e., $\Psi_i[f]$, where $\Psi_i$ * are the node functionals of the element - * (see also @ref GlossNodes "Node values or node functionals"). + * (see also + * @ref GlossNodes "Node values or node functionals"). * The values $\Psi_i[f]$ are then the expansion coefficients * for the shape functions of the finite element function that * interpolates the given function $f(x)$, i.e., @@ -2163,7 +2164,8 @@ public: * of information. * * The exact form of $f_i$ depends on the element. For example, for scalar - * @ref GlossLagrange "Lagrange elements", we have that in fact + * @ref GlossLagrange "Lagrange elements", + * we have that in fact * $\Psi_i[\varphi] = \varphi(\hat{\mathbf x}_i)$. If you combine multiple * scalar Lagrange elements via an FESystem object, then * $\Psi_i[\varphi] = \varphi(\hat{\mathbf x}_i)_{c(i)}$ where $c(i)$ diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index df21725e74..0a368a3229 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -34,14 +34,16 @@ DEAL_II_NAMESPACE_OPEN * triangulations for some basic geometries. * * Some of these functions receive a flag @p colorize. If this is set, parts of - * the boundary receive different @ref GlossBoundaryIndicator "boundary - * indicators" allowing them to be distinguished for the purpose of evaluating + * the boundary receive different + * @ref GlossBoundaryIndicator "boundary indicators" + * allowing them to be distinguished for the purpose of evaluating * different boundary conditions. * * If the domain is curved, each of the domain parts that should be * refined by following an appropriate Manifold description will - * receive a different @ref GlossManifoldIndicator "manifold - * indicator", and the correct Manifold descriptor will be attached to + * receive a different + * @ref GlossManifoldIndicator "manifold indicator", + * and the correct Manifold descriptor will be attached to * the Triangulation. Notice that if you later tranform the * triangulation, you have to make sure you attach the correct new Manifold * to the triangulation. diff --git a/include/deal.II/grid/grid_in.h b/include/deal.II/grid/grid_in.h index 2bdb215258..4de821d350 100644 --- a/include/deal.II/grid/grid_in.h +++ b/include/deal.II/grid/grid_in.h @@ -41,8 +41,7 @@ template struct CellData; * boundary ids to cells or faces (see * @ref GlossMaterialId "this" * and - * @ref - * GlossBoundaryIndicator "this" + * @ref GlossBoundaryIndicator "this" * glossary entry for more information). * * @note Since deal.II only supports line, quadrilateral and hexahedral diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 5d4e850f2c..56c0003c44 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -821,7 +821,8 @@ namespace internal * material id associated with a cell during assembly of the bilinear form, * and use it to determine (e.g., by table lookup, or a sequence of if-else * statements) what the correct material coefficients would be for that cell. - * See also @ref GlossMaterialId "this glossary entry". + * See also + * @ref GlossMaterialId "this glossary entry". * * This material_id may be set upon construction of a triangulation (through * the CellData data structure), or later through use of cell iterators. For a @@ -1018,8 +1019,8 @@ namespace internal * cell, new face midpoints, and (in 3D) new line midpoints. Therefore if your * new boundary vertex is too near the center of the old quadrilateral or * hexahedron, the distance to the midpoint vertex will become too small, thus - * generating distorted cells. This issue is discussed extensively in @ref - * GlossDistorted "distorted cells". + * generating distorted cells. This issue is discussed extensively in + * @ref GlossDistorted "distorted cells". * *

Getting notice when a triangulation changes

* diff --git a/include/deal.II/hp/dof_handler.h b/include/deal.II/hp/dof_handler.h index 263ce64be3..ad53f27506 100644 --- a/include/deal.II/hp/dof_handler.h +++ b/include/deal.II/hp/dof_handler.h @@ -150,7 +150,8 @@ namespace hp * @p active_fe_index used there. That's because we don't even know * whether these cells exist at all, and even if they did, the * current processor does not know anything specific about them. - * See @ref GlossArtificialCell "the glossary entry on artificial cells" + * See + * @ref GlossArtificialCell "the glossary entry on artificial cells" * for more information. * * diff --git a/include/deal.II/lac/block_indices.h b/include/deal.II/lac/block_indices.h index 0a72ecc3bf..fcdb242016 100644 --- a/include/deal.II/lac/block_indices.h +++ b/include/deal.II/lac/block_indices.h @@ -51,7 +51,8 @@ DEAL_II_NAMESPACE_OPEN * ones. * * @ingroup data - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, Guido Kanschat, 2000, 2007, 2011 */ class BlockIndices : public Subscriptor diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index 57e0f329c1..9a7763cc37 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -99,7 +99,8 @@ namespace mg /** * Implementation of the multigrid method. The implementation supports both * continuous and discontinuous elements and follows the procedure described in - * the @ref mg_paper "multigrid paper by Janssen and Kanschat". + * the + * @ref mg_paper "multigrid paper by Janssen and Kanschat". * * The function which starts a multigrid cycle on the finest level is cycle(). * Depending on the cycle type chosen with the constructor (see enum Cycle), -- 2.39.5