From: Timo Heister Date: Sat, 6 Feb 2016 22:40:54 +0000 (-0500) Subject: manual formatting fixes for wrapcomments.py X-Git-Tag: v8.4.0-rc2~27^2~7 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=2e67d48630f2527d5800fc6b9a8dd3885591bda1;p=dealii.git manual formatting fixes for wrapcomments.py --- diff --git a/include/deal.II/base/mpi.h b/include/deal.II/base/mpi.h index 0783b6be24..07310ca8f6 100644 --- a/include/deal.II/base/mpi.h +++ b/include/deal.II/base/mpi.h @@ -65,15 +65,18 @@ namespace Utilities { /** * Return the number of MPI processes there exist in the given - * @ref GlossMPICommunicator "communicator" object. If this is + * @ref GlossMPICommunicator "communicator" + * object. If this is * a sequential job, it returns 1. */ unsigned int n_mpi_processes (const MPI_Comm &mpi_communicator); /** - * Return the @ref GlossMPIRank "rank of the present MPI process" + * Return the + * @ref GlossMPIRank "rank of the present MPI process" * in the space of processes described by the given - * @ref GlossMPICommunicator "communicator". This will be a unique value for + * @ref GlossMPICommunicator "communicator". + * This will be a unique value for * each process between zero and (less than) the number of all processes * (given by get_n_mpi_processes()). */ @@ -85,7 +88,9 @@ namespace Utilities * processors. To do that, the other processors need to know who to expect * messages from. This function computes this information. * - * @param mpi_comm A @ref GlossMPICommunicator "communicator" that describes + * @param mpi_comm A + * @ref GlossMPICommunicator "communicator" + * that describes * the processors that are going to communicate with each other. * * @param destinations The list of processors the current process wants to @@ -103,7 +108,9 @@ namespace Utilities const std::vector &destinations); /** - * Given a @ref GlossMPICommunicator "communicator", generate a new + * Given a + * @ref GlossMPICommunicator "communicator", + * generate a new * communicator that contains the * same set of processors but that has a different, unique identifier. * @@ -118,7 +125,8 @@ namespace Utilities /** * Return the sum over all processors of the value @p t. This function is - * collective over all processors given in the @ref GlossMPICommunicator "communicator". + * collective over all processors given in the + * @ref GlossMPICommunicator "communicator". * If deal.II is * not configured for use of MPI, this function simply returns the value * of @p t. This function corresponds to the MPI_Allreduce @@ -203,7 +211,8 @@ namespace Utilities /** * Return the maximum over all processors of the value @p t. This function * is collective over all processors given in the - * @ref GlossMPICommunicator "communicator". If deal.II + * @ref GlossMPICommunicator "communicator". + * If deal.II * is not configured for use of MPI, this function simply returns the * value of @p t. This function corresponds to the * MPI_Allreduce function, i.e. all processors receive the @@ -254,7 +263,8 @@ namespace Utilities /** * Return the minimum over all processors of the value @p t. This function * is collective over all processors given in the - * @ref GlossMPICommunicator "communicator". If deal.II + * @ref GlossMPICommunicator "communicator". + * If deal.II * is not configured for use of MPI, this function simply returns the * value of @p t. This function corresponds to the * MPI_Allreduce function, i.e. all processors receive the @@ -321,7 +331,8 @@ namespace Utilities /** * Returns sum, average, minimum, maximum, processor id of minimum and * maximum as a collective operation of on the given MPI - * @ref GlossMPICommunicator "communicator" @p mpi_communicator. + * @ref GlossMPICommunicator "communicator" + * @p mpi_communicator. * Each processor's value is given in @p my_value and * the result will be returned. The result is available on all machines. * diff --git a/include/deal.II/base/polynomials_bernstein.h b/include/deal.II/base/polynomials_bernstein.h index 013def14ca..5d5baa1ae0 100644 --- a/include/deal.II/base/polynomials_bernstein.h +++ b/include/deal.II/base/polynomials_bernstein.h @@ -11,7 +11,7 @@ DEAL_II_NAMESPACE_OPEN /** * This class implements Bernstein basis polynomials of desire degree as described in * http://www.idav.ucdavis.edu/education/CAGDNotes/Bernstein-Polynomials.pdf - * Paragraph: Converting from the Bernstein Basis to the Power Basis + * in the paragraph "Converting from the Bernstein Basis to the Power Basis". * * They are used to create the Bernstein finite element FE_Bernstein. * @@ -24,11 +24,19 @@ class PolynomialsBernstein : public Polynomials::Polynomial { public: /** - * Construct the #index -th Bernstein Polynomial of degree #degree. + * Construct the @p index -th Bernstein Polynomial of degree @p degree. * - * B_{index, degree} (t) = binom(degree, index) * t^index * (1 - t)^{degree - index} = - * = sum_{i = index}^degree (-1)^{i - index} * - * binom(degree, i) * binom(i, index) * t^i + * @f{aligned*}{ + * B_{\text{index}, \text{degree}} (t) + * &= \text{binom}(\text{degree}, \text{index}) + * \cdot t^{\text{index}} + * \cdot (1 - t)^{\text{degree} - \text{index}} \\ + * &= \sum_{i = \text{index}}^\text{degree} + * \cdot (-1)^{i - \text{index}} + * \cdot \text{binom}(\text{degree}, i) + * \cdot \text{binom}(i, \text{index}) + * \cdot t^i + * @f} * * @param index * @param degree diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 30605c3cc4..b5aa8391ed 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -52,7 +52,7 @@ class Tensor<-1, dim, Number> /** * This class is a specialized version of the * Tensor class. It handles tensors of rank zero, - * i.e. scalars. The second template argument @param dim is ignored. + * i.e. scalars. The second template argument @p dim is ignored. * * This class exists because in some cases we want to construct objects of * type Tensor@, which should expand to scalars, diff --git a/include/deal.II/base/tensor_product_polynomials_bubbles.h b/include/deal.II/base/tensor_product_polynomials_bubbles.h index fa8fef06a5..fee490cfc6 100644 --- a/include/deal.II/base/tensor_product_polynomials_bubbles.h +++ b/include/deal.II/base/tensor_product_polynomials_bubbles.h @@ -100,7 +100,7 @@ public: const Point &p) const; /** - * Computes the order @tparam order derivative of the ith tensor + * Computes the order @p order derivative of the ith tensor * product polynomial at unit_point. Here i is given in * tensor product numbering. * diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index bea1e4dc40..bb268a9e52 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -125,7 +125,8 @@ namespace internal * A class that gives access to the degrees of freedom stored in a DoFHandler * or hp::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. + * explained in more 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 diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index 3fdac2a8a8..7ef51ae428 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -455,7 +455,9 @@ namespace DoFTools * sparsity pattern matches the number of degrees of freedom and * that enough unused nonzero entries are left to fill the * sparsity pattern if the sparsity pattern is of "static" kind - * (see @ref Sparsity for more information on what this + * (see + * @ref Sparsity + * for more information on what this * means). The nonzero entries generated by this function are * added to possible previous content of the object, i.e., * previously added entries are not removed. @@ -533,7 +535,9 @@ namespace DoFTools * * There is a complication if some or all of the shape functions of the * finite element in use are non-zero in more than one component (in deal.II - * speak: they are @ref GlossPrimitive "non-primitive finite elements"). In + * speak: they are + * @ref GlossPrimitive "non-primitive finite elements"). + * In * this case, the coupling element * corresponding to the first non-zero component is taken and additional * ones for this component are ignored. @@ -610,7 +614,9 @@ namespace DoFTools * sparsity pattern matches the number of degrees of freedom and * that enough unused nonzero entries are left to fill the * sparsity pattern if the sparsity pattern is of "static" kind - * (see @ref Sparsity for more information on what this + * (see + * @ref Sparsity + * for more information on what this * means). The nonzero entries generated by this function are * added to possible previous content of the object, i.e., * previously added entries are not removed. diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 946aba272a..cb8144f687 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -58,12 +58,17 @@ namespace hp * node constraints), as well as to other finite element spaces * defined on the same cell (e.g., when doing $p$ refinement). * - %Functions that describe the properties of individual shape functions, - * for example which @ref GlossComponent "vector components" of a - * @ref vector_valued "vector-valued finite element's" shape function - * is nonzero, or whether an element is @ref GlossPrimitive "primitive". + * for example which + * @ref GlossComponent "vector components" + * of a + * @ref vector_valued "vector-valued finite element's" + * shape function + * is nonzero, or whether an element is + * @ref GlossPrimitive "primitive". * - For elements that are interpolatory, such as the common $Q_p$ * Lagrange elements, data that describes where their - * @ref GlossSupport "support points" are located. + * @ref GlossSupport "support points" + * are located. * - %Functions that define the interface to the FEValues class that is * almost always used to access finite element shape functions from * user code. @@ -105,7 +110,8 @@ namespace hp * derived classes can overload that describes whether a particular * feature is implemented. An example is whether an element implements * the information necessary to use it in the $hp$ finite element - * context (see @ref hp "hp finite element support"). + * context (see + * @ref hp "hp finite element support"). * * *

Nomenclature

@@ -116,7 +122,8 @@ namespace hp * *

Components and blocks

* - * @ref vector_valued "Vector-valued finite element" are elements used for + * @ref vector_valued "Vector-valued finite element" + * are elements used for * systems of partial differential equations. Oftentimes, they are composed * via the FESystem class (which is itself derived from the current class), * but there are also non-composed elements that have multiple components @@ -142,7 +149,8 @@ namespace hp * Oftentimes, one may want to split linear system into blocks so that they * reflect the structure of the underlying operator. This is typically not * done based on vector components, but based on the use of - * @ref GlossBlock "blocks", and the result is then used to substructure + * @ref GlossBlock "blocks", + * and the result is then used to substructure * objects of type BlockVector, BlockSparseMatrix, BlockMatrixArray, and so on. * If you use non-primitive elements, you cannot determine the block number by * FiniteElement::system_to_component_index(). Instead, you can use @@ -162,7 +170,8 @@ namespace hp * Most finite elements are defined by mapping from the reference cell to * a concrete cell. Consequently, the support points are then defined on * the reference ("unit") cell, see - * @ref GlossSupport "this glossary entry". The support points on a concrete + * @ref GlossSupport "this glossary entry". + * The support points on a concrete * cell can then be computed by mapping the unit support points, using the * Mapping class interface and derived classes, typically via the FEValues * class. @@ -214,7 +223,9 @@ namespace hp * of other, similar elements first. Since many of the more complicated * pieces of a finite element interface have to do with how they interact * with mappings, quadrature, and the FEValues class, you will also want - * to read through the @ref FE_vs_Mapping_vs_FEValues documentation + * to read through the + * @ref FE_vs_Mapping_vs_FEValues + * documentation * module. * * @@ -269,7 +280,9 @@ namespace hp * relevant to the case where the same finite element space is used on * neighboring (but differently refined) cells. The case that the finite * element spaces on different sides of a face are different, i.e., - * the $hp$ case (see @ref hp "hp finite element support") is handled + * the $hp$ case (see + * @ref hp "hp finite element support") + * is handled * by separate functions. See the FiniteElement::get_face_interpolation_matrix() * and FiniteElement::get_subface_interpolation_matrix() functions. * @@ -363,7 +376,8 @@ namespace hp * ConstraintMatrix object.) However, this is of no concern for the * FiniteElement and derived classes since they only act locally on one cell * and its immediate neighbor, and do not see the bigger picture. The - * @ref hp_paper details how such chains are handled in practice. + * @ref hp_paper + * details how such chains are handled in practice. * * *

Helper functions

@@ -675,7 +689,8 @@ public: * components this shape function is nonzero (after mapping the shape * function to the real cell). For "primitive" shape * functions, this component mask will have a single entry (see - * @ref GlossPrimitive for more information about primitive elements). + * @ref GlossPrimitive + * for more information about primitive elements). * On the other hand, for elements such as the Raviart-Thomas or Nedelec * elements, shape functions are nonzero in more than one vector component * (after mapping to the real cell) and the given component mask will @@ -2335,7 +2350,9 @@ protected: * makes the mapping class produce the inverse of the Jacobian matrix. * * An extensive discussion of the interaction between this function and - * FEValues can be found in the @ref FE_vs_Mapping_vs_FEValues documentation + * FEValues can be found in the + * @ref FE_vs_Mapping_vs_FEValues + * documentation * module. * * @see UpdateFlags @@ -2388,7 +2405,9 @@ protected: * in the object returned. * * An extensive discussion of the interaction between this function and - * FEValues can be found in the @ref FE_vs_Mapping_vs_FEValues documentation + * FEValues can be found in the + * @ref FE_vs_Mapping_vs_FEValues + * documentation * module. See also the documentation of the InternalDataBase class. * * @param[in] update_flags A set of UpdateFlags values that describe @@ -2555,8 +2574,9 @@ protected: * of these functions in derived classes). * * An extensive discussion of the interaction between this function and - * FEValues can be found in the @ref FE_vs_Mapping_vs_FEValues documentation - * module. + * FEValues can be found in the + * @ref FE_vs_Mapping_vs_FEValues + * documentation module. * * @param[in] cell The cell of the triangulation for which this function * is to compute a mapping from the reference cell to. diff --git a/include/deal.II/fe/fe_rannacher_turek.h b/include/deal.II/fe/fe_rannacher_turek.h index 2f0c942df4..2bdb858904 100644 --- a/include/deal.II/fe/fe_rannacher_turek.h +++ b/include/deal.II/fe/fe_rannacher_turek.h @@ -37,7 +37,9 @@ DEAL_II_NAMESPACE_OPEN *

Interpolation

* *

Node values

- * The @ref GlossNodes "node values" are moments on faces. + * The + * @ref GlossNodes "node values" + * are moments on faces. * *

Generalized support points

* To calculate the node values, we are using a QGauss rule on each face. diff --git a/include/deal.II/fe/fe_update_flags.h b/include/deal.II/fe/fe_update_flags.h index 05f3224452..01dc893b28 100644 --- a/include/deal.II/fe/fe_update_flags.h +++ b/include/deal.II/fe/fe_update_flags.h @@ -56,7 +56,8 @@ template class FiniteElement; * More information on the use of this type both in user code as * well as internally can be found in the documentation modules on * @ref UpdateFlags "The interplay of UpdateFlags, Mapping, and FiniteElement in FEValues" - * and @ref FE_vs_Mapping_vs_FEValues "How Mapping, FiniteElement, and FEValues work together". + * and + * @ref FE_vs_Mapping_vs_FEValues "How Mapping, FiniteElement, and FEValues work together". */ enum UpdateFlags { diff --git a/include/deal.II/fe/mapping.h b/include/deal.II/fe/mapping.h index cfb136073f..4fdb212e5f 100644 --- a/include/deal.II/fe/mapping.h +++ b/include/deal.II/fe/mapping.h @@ -590,7 +590,9 @@ protected: * this does not take away from the instructiveness of the example.) * * An extensive discussion of the interaction between this function and - * FEValues can be found in the @ref FE_vs_Mapping_vs_FEValues documentation + * FEValues can be found in the + * @ref FE_vs_Mapping_vs_FEValues + * documentation * module. * * @see UpdateFlags @@ -622,7 +624,9 @@ protected: * this function. Ownership will therefore rest with the caller. * * An extensive discussion of the interaction between this function and - * FEValues can be found in the @ref FE_vs_Mapping_vs_FEValues documentation + * FEValues can be found in the + * @ref FE_vs_Mapping_vs_FEValues + * documentation * module. * * @param update_flags A set of flags that define what is expected of @@ -759,7 +763,9 @@ protected: * passed to this function. * * An extensive discussion of the interaction between this function and - * FEValues can be found in the @ref FE_vs_Mapping_vs_FEValues documentation + * FEValues can be found in the + * @ref FE_vs_Mapping_vs_FEValues + * documentation * module. * * @param[in] cell The cell of the triangulation for which this function diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 299cc8004d..9c12bb78dd 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -38,8 +38,8 @@ template class SparseMatrix; * triangulations for some basic geometries. * * Some of these functions receive a flag @p colorize. If this is set, parts - * of the boundary receive different boundary indicators - * (@ref GlossBoundaryIndicator), + * of the boundary receive different + * @ref GlossBoundaryIndicator "boundary indicators"), * allowing them to be distinguished for the purpose of attaching geometry * objects and evaluating different boundary conditions. * @@ -452,11 +452,13 @@ namespace GridGenerator * triangulation.refine_global(3); * @endcode * - * See the @ref manifold "documentation module on manifolds" for + * See the + * @ref manifold "documentation module on manifolds" + * for * more details. * - * @image html sphere.png - * @image html sphere_section.png + * @image html sphere.png + * @image html sphere_section.png * * @note The triangulation needs to be void upon calling this function. */ @@ -562,8 +564,8 @@ namespace GridGenerator * * Examples in two and three dimensions are * - * @image html hyper_cross_2d.png - * @image html hyper_cross_3d.png + * @image html hyper_cross_2d.png + * @image html hyper_cross_3d.png * * @author Guido Kanschat * @date 2015 @@ -642,7 +644,8 @@ namespace GridGenerator * below). * * While the SphericalManifold, that is demonstrated in the documentation of the - * @ref manifold "documentation module on manifolds", creates reasonable meshes + * @ref manifold "documentation module on manifolds", + * creates reasonable meshes * for any number of @p n_cells if attached to all cells and boundaries, the * situation is less than ideal when only attaching a HyperShellBoundary. Then, * only vertices on the boundaries are placed at the correct distance from the @@ -1041,7 +1044,8 @@ namespace GridGenerator * vertices. * * @tparam MeshType A type that satisfies the requirements of the - * @ref ConceptMeshType "MeshType concept". The map that is returned will be + * @ref ConceptMeshType "MeshType concept". + * The map that is returned will be * between cell iterators pointing into the container describing the surface * mesh and face iterators of the volume mesh container. If MeshType is * DoFHandler or hp::DoFHandler, then the function will re-build the diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 2ce468c207..d73d8f9a30 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -343,7 +343,8 @@ namespace GridTools * located closest to a given point. * * @param mesh A variable of a type that satisfies the requirements of - * the @ref ConceptMeshType "MeshType concept". + * the + * @ref ConceptMeshType "MeshType concept". * @param p The point for which we want to find the closest vertex. * @return The index of the closest vertex found. * @@ -363,7 +364,8 @@ namespace GridTools * vertex of a cell or be a hanging node located on a face or an edge of it. * * @param container A variable of a type that satisfies the requirements of - * the @ref ConceptMeshType "MeshType concept". + * the + * @ref ConceptMeshType "MeshType concept". * @param vertex_index The index of the vertex for which we try to find * adjacent cells. * @return A vector of cells that lie adjacent to the given vertex. @@ -400,7 +402,8 @@ namespace GridTools * additional computational cost. * * @param mesh A variable of a type that satisfies the requirements of - * the @ref ConceptMeshType "MeshType concept". + * the + * @ref ConceptMeshType "MeshType concept". * @param p The point for which we want to find the surrounding cell. * @return An iterator into the mesh that points to the surrounding cell. * @@ -448,7 +451,8 @@ namespace GridTools * @param mapping The mapping used to determine whether the given point is * inside a given cell. * @param mesh A variable of a type that satisfies the requirements of - * the @ref ConceptMeshType "MeshType concept". + * the + * @ref ConceptMeshType "MeshType concept". * @param p The point for which we want to find the surrounding cell. * @return An pair of an iterators into the mesh that points to the * surrounding cell, and of the coordinates of that point inside the cell in @@ -990,7 +994,8 @@ namespace GridTools * of Container from the function call. You need to * specify it as an explicit template argument following the * function name. This type has to satisfy the requirements of a - * mesh container (see @ref ConceptMeshType). + * mesh container (see + * @ref ConceptMeshType). * * @param[in] patch_cells A vector of active cells for which * this function finds the parents at the coarsest common @@ -1060,7 +1065,8 @@ namespace GridTools * of Container from the function call. You need to * specify it as an explicit template argument following the * function name. This type that satisfies the requirements of a - * mesh container (see @ref ConceptMeshType). + * mesh container (see + * @ref ConceptMeshType). * * @param[in] patch A vector of active cells from a common triangulation. * These cells may or may not all be at the same refinement level. diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 89a1016540..a4723ba3a7 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -434,7 +434,8 @@ namespace internal * dependent of the dimension and there only exist specialized versions for * distinct dimensions. * - * This class satisfies the @ref ConceptMeshType "MeshType concept" + * This class satisfies the + * @ref ConceptMeshType "MeshType concept" * requirements. * *

Structure and iterators

@@ -1968,7 +1969,7 @@ public: * A structure that has boost::signal objects for a number of actions that a * triangulation can do to itself. Please refer to the * "Getting notice when a triangulation changes" section in the general - * documentation of the @ref Triangulation class for more information + * documentation of the Triangulation class for more information * and examples. * * For documentation on signals, see @@ -2816,7 +2817,9 @@ public: * * This doesn't seem to be very useful but allows to write code that * can access the underlying triangulation for anything that satisfies - * the @ref ConceptMeshType "MeshType concept" (which may not only be a + * the + * @ref ConceptMeshType "MeshType concept" + * (which may not only be a * triangulation, but also a DoFHandler, for example). */ Triangulation & diff --git a/include/deal.II/lac/block_linear_operator.h b/include/deal.II/lac/block_linear_operator.h index ddb56bcc24..57d07443fc 100644 --- a/include/deal.II/lac/block_linear_operator.h +++ b/include/deal.II/lac/block_linear_operator.h @@ -427,8 +427,9 @@ block_operator(const BlockMatrixType &block_matrix) * * A variant of above function that encapsulates a given collection @p ops * of LinearOperators into a block structure. Here, it is assumed that - * Range and Domain are blockvectors, i.e., derived from @ref - * BlockVectorBase. The individual linear operators in @p ops must act on + * Range and Domain are blockvectors, i.e., derived from + * @ref BlockVectorBase. + * The individual linear operators in @p ops must act on * the underlying vector type of the block vectors, i.e., on * Domain::BlockType yielding a result in Range::BlockType. * diff --git a/include/deal.II/lac/constrained_linear_operator.h b/include/deal.II/lac/constrained_linear_operator.h index 19a1969b25..8fdb4ca42c 100644 --- a/include/deal.II/lac/constrained_linear_operator.h +++ b/include/deal.II/lac/constrained_linear_operator.h @@ -48,7 +48,8 @@ DEAL_II_NAMESPACE_OPEN * The LinearOperator object created by this function is primarily used * internally in constrained_linear_operator() to build up a modified * system of linear equations. How to solve a linear system of equations - * with this approach is explained in detail in the @ref constraints + * with this approach is explained in detail in the + * @ref constraints * module. * * @author Mauro Bardelloni, Matthias Maier, 2015 @@ -215,7 +216,8 @@ LinearOperator project_to_constrained_linear_operator( * with a given (unconstrained) system matrix $A$, right hand side $b$, and * linear constraints $C$ with inhomogeneities $k$. * - * A detailed explanation of this approach is given in the @ref constraints + * A detailed explanation of this approach is given in the + * @ref constraints * module. * * @author Mauro Bardelloni, Matthias Maier, 2015 @@ -262,7 +264,8 @@ constrained_linear_operator(const ConstraintMatrix &constraint_matrix, * with a given (unconstrained) system matrix $A$, right hand side $b$, and * linear constraints $C$ with inhomogeneities $k$. * - * A detailed explanation of this approach is given in the @ref constraints + * A detailed explanation of this approach is given in the + * @ref constraints * module. * * @author Mauro Bardelloni, Matthias Maier, 2015 diff --git a/include/deal.II/lac/constraint_matrix.h b/include/deal.II/lac/constraint_matrix.h index a58ba01784..41fac0c947 100644 --- a/include/deal.II/lac/constraint_matrix.h +++ b/include/deal.II/lac/constraint_matrix.h @@ -177,7 +177,8 @@ public: * constrained inside this ConstraintMatrix. In a calculation with a * DoFHandler object based on parallel::distributed::Triangulation * or parallel::shared::Triangulation, one should use the set of locally - * relevant dofs (see @ref GlossLocallyRelevenDof). + * relevant dofs (see + * @ref GlossLocallyRelevantDof). * * The given IndexSet allows the ConstraintMatrix to save memory by just not * caring about degrees of freedom that are not of importance to the diff --git a/include/deal.II/lac/parallel_vector.h b/include/deal.II/lac/parallel_vector.h index 74c9e58da7..711f489722 100644 --- a/include/deal.II/lac/parallel_vector.h +++ b/include/deal.II/lac/parallel_vector.h @@ -148,7 +148,9 @@ namespace parallel * 2^32-1 or approximately 4 billion in case 64 bit integers * are disabled at configuration of deal.II (default case) or * 2^64-1 or approximately 10^19 if 64 bit - * integers are enabled (see the glossary entry on @ref GlobalDoFIndex for + * integers are enabled (see the glossary entry on + * @ref GlobalDoFIndex + * for * further information). * * The second relevant index type is the local index used within one MPI diff --git a/include/deal.II/lac/parpack_solver.h b/include/deal.II/lac/parpack_solver.h index e88571a4e9..0281678bbc 100644 --- a/include/deal.II/lac/parpack_solver.h +++ b/include/deal.II/lac/parpack_solver.h @@ -84,26 +84,26 @@ extern "C" { * * The ArpackSolver can be used in application codes in the * following way: - @code - SolverControl solver_control (1000, 1e-9); - const unsigned int num_arnoldi_vectors = 2*size_of_spectrum + 2; - PArpackSolver::AdditionalData - additional_data(num_arnoldi_vectors, - dealii::PArpackSolver::largest_magnitude, - true); - - PArpackSolver eigensolver (solver_control, - mpi_communicator, - additional_data); - eigensolver.set_shift(sigma); - eigensolver.reinit(locally_owned_dofs); - eigensolver.solve (A, - B, - OP, - lambda, - x, - size_of_spectrum); - @endcode + * @code + * SolverControl solver_control (1000, 1e-9); + * const unsigned int num_arnoldi_vectors = 2*size_of_spectrum + 2; + * PArpackSolver::AdditionalData + * additional_data(num_arnoldi_vectors, + * dealii::PArpackSolver::largest_magnitude, + * true); + * + * PArpackSolver eigensolver (solver_control, + * mpi_communicator, + * additional_data); + * eigensolver.set_shift(sigma); + * eigensolver.reinit(locally_owned_dofs); + * eigensolver.solve (A, + * B, + * OP, + * lambda, + * x, + * size_of_spectrum); + * @endcode * for the generalized eigenvalue problem $Ax=B\lambda x$, where the * variable size_of_spectrum tells PARPACK the number of * eigenvector/eigenvalue pairs to solve for. Here, diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index 813d03c700..ee5d0b6f1c 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -524,7 +524,8 @@ public: * The MatrixType class used is required to have functions * precondition_SOR(VectorType&, const VectorType&, double) and * precondition_TSOR(VectorType&, const VectorType&, double). This - * class satisfies the @ref ConceptRelaxationType "relaxation concept". + * class satisfies the + * @ref ConceptRelaxationType "relaxation concept". * * @code * // Declare related objects diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index 7048d18aca..e589456479 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -361,7 +361,9 @@ protected: * * @note Instantiations for this template are provided for @ and * @; others can be generated in application programs (see the - * section on @ref Instantiations in the manual). + * section on + * @ref Instantiations + * in the manual). * * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2003 */ diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index 0d041d1a1f..e918b2f646 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -433,7 +433,9 @@ namespace SparseMatrixIterators /** * Sparse matrix. This class implements the functionality to store * matrix entry values in the locations denoted by a - * SparsityPattern. See @ref Sparsity for a discussion about the + * SparsityPattern. See + * @ref Sparsity + * for a discussion about the * separation between sparsity patterns and matrices. * * The elements of a SparseMatrix are stored in the same order in which the diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index dc34ffa865..c4e6c6f7b3 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -298,7 +298,9 @@ namespace SparsityPatternIterators * A class that can store which elements of a matrix are nonzero (or, * in fact, may be nonzero) and for which we have to allocate * memory to store their values. This class is an example of the - * "static" type of sparsity patters (see @ref Sparsity). It uses the + * "static" type of sparsity patters (see + * @ref Sparsity). + * It uses the * compressed * row storage (CSR) format to store data, and is used as the * basis for the SparseMatrix class. @@ -321,7 +323,8 @@ namespace SparsityPatternIterators * systems, it is rarely set up directly due to the way it stores its * information. Rather, one typically goes through an intermediate format * first, see for example the step-2 tutorial program as well as the - * documentation module @ref Sparsity. + * documentation module + * @ref Sparsity. * * @author Wolfgang Bangerth, Guido Kanschat and others */ diff --git a/include/deal.II/meshworker/assembler.h b/include/deal.II/meshworker/assembler.h index b63c138c83..1f0ba59369 100644 --- a/include/deal.II/meshworker/assembler.h +++ b/include/deal.II/meshworker/assembler.h @@ -93,8 +93,8 @@ namespace MeshWorker * used locally. * * In the block model, each of the blocks of the local vectors corresponds - * to the restriction of a single block of the system to this cell - (* @ref GlossBlock). + * to the restriction of a single block of the system to this cell (see + * @ref GlossBlock). * Thus, the size of this local block is the number of degrees of freedom * of the corresponding base element of the FESystem. *