From 8aff68aefc818a8563a590f45bdddbb5bc4c6019 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Thu, 25 Dec 2014 15:00:11 -0500 Subject: [PATCH] put @ref in separate line --- include/deal.II/base/derivative_form.h | 7 +- include/deal.II/base/exceptions.h | 4 +- include/deal.II/base/function.h | 4 +- include/deal.II/base/geometry_info.h | 26 ++- include/deal.II/base/graph_coloring.h | 3 +- include/deal.II/base/index_set.h | 3 +- include/deal.II/base/iterator_range.h | 3 +- include/deal.II/base/multithread_info.h | 8 +- include/deal.II/base/parameter_handler.h | 21 ++- include/deal.II/base/qprojector.h | 5 +- include/deal.II/base/quadrature.h | 4 +- include/deal.II/base/types.h | 40 +++-- include/deal.II/base/work_stream.h | 21 ++- include/deal.II/distributed/tria.h | 28 ++- include/deal.II/dofs/dof_accessor.h | 25 ++- include/deal.II/dofs/dof_handler.h | 27 ++- include/deal.II/dofs/dof_iterator_selector.h | 14 +- include/deal.II/dofs/dof_renumbering.h | 11 +- include/deal.II/dofs/dof_tools.h | 113 ++++++++---- include/deal.II/fe/block_mask.h | 7 +- include/deal.II/fe/component_mask.h | 7 +- include/deal.II/fe/fe.h | 78 +++++--- include/deal.II/fe/fe_abf.h | 8 +- include/deal.II/fe/fe_base.h | 25 ++- include/deal.II/fe/fe_dgp.h | 3 +- include/deal.II/fe/fe_dgp_monomial.h | 3 +- include/deal.II/fe/fe_dgp_nonparametric.h | 3 +- include/deal.II/fe/fe_dgq.h | 3 +- include/deal.II/fe/fe_face.h | 9 +- include/deal.II/fe/fe_nedelec.h | 8 +- include/deal.II/fe/fe_nothing.h | 3 +- include/deal.II/fe/fe_q_base.h | 13 +- include/deal.II/fe/fe_q_hierarchical.h | 3 +- include/deal.II/fe/fe_q_iso_q1.h | 3 +- include/deal.II/fe/fe_raviart_thomas.h | 8 +- include/deal.II/fe/fe_system.h | 24 ++- include/deal.II/fe/fe_tools.h | 7 +- include/deal.II/fe/fe_update_flags.h | 3 +- include/deal.II/fe/fe_values.h | 36 ++-- include/deal.II/fe/fe_values_extractors.h | 18 +- include/deal.II/fe/mapping.h | 10 +- include/deal.II/grid/grid_generator.h | 7 +- include/deal.II/grid/grid_in.h | 3 +- include/deal.II/grid/grid_out.h | 4 +- include/deal.II/grid/grid_tools.h | 12 +- include/deal.II/grid/tria.h | 168 +++++++++++------ include/deal.II/grid/tria_accessor.h | 170 +++++++++++++----- include/deal.II/grid/tria_iterator_selector.h | 9 +- include/deal.II/hp/dof_handler.h | 21 ++- include/deal.II/hp/fe_collection.h | 37 ++-- include/deal.II/hp/mapping_collection.h | 4 +- include/deal.II/hp/q_collection.h | 4 +- include/deal.II/lac/block_indices.h | 7 +- include/deal.II/lac/block_matrix.h | 3 +- include/deal.II/lac/block_matrix_base.h | 12 +- include/deal.II/lac/block_sparse_matrix.h | 3 +- include/deal.II/lac/block_sparse_matrix_ez.h | 3 +- include/deal.II/lac/block_sparsity_pattern.h | 35 ++-- include/deal.II/lac/block_vector.h | 11 +- include/deal.II/lac/block_vector_base.h | 8 +- include/deal.II/lac/chunk_sparse_matrix.h | 16 +- include/deal.II/lac/chunk_sparsity_pattern.h | 4 +- .../lac/compressed_set_sparsity_pattern.h | 17 +- .../lac/compressed_simple_sparsity_pattern.h | 9 +- .../deal.II/lac/compressed_sparsity_pattern.h | 9 +- include/deal.II/lac/constraint_matrix.h | 33 ++-- include/deal.II/lac/householder.h | 4 +- include/deal.II/lac/matrix_lib.h | 4 +- include/deal.II/lac/parallel_block_vector.h | 12 +- include/deal.II/lac/parallel_vector.h | 45 +++-- include/deal.II/lac/petsc_matrix_base.h | 5 +- .../deal.II/lac/petsc_parallel_block_vector.h | 4 +- include/deal.II/lac/petsc_precondition.h | 32 +++- include/deal.II/lac/petsc_vector_base.h | 8 +- include/deal.II/lac/precondition_block.h | 15 +- include/deal.II/lac/schur_matrix.h | 3 +- include/deal.II/lac/slepc_solver.h | 8 +- include/deal.II/lac/sparse_direct.h | 5 +- include/deal.II/lac/sparse_ilu.h | 9 +- include/deal.II/lac/sparse_matrix.h | 16 +- include/deal.II/lac/sparse_vanka.h | 4 +- include/deal.II/lac/sparsity_pattern.h | 7 +- include/deal.II/lac/swappable_vector.h | 4 +- include/deal.II/lac/trilinos_block_vector.h | 9 +- .../lac/trilinos_parallel_block_vector.h | 11 +- include/deal.II/lac/trilinos_sparse_matrix.h | 5 +- include/deal.II/lac/trilinos_vector.h | 36 ++-- include/deal.II/lac/trilinos_vector_base.h | 8 +- include/deal.II/lac/vector.h | 8 +- include/deal.II/meshworker/assembler.h | 4 +- include/deal.II/multigrid/mg_base.h | 7 +- .../multigrid/mg_dof_iterator_selector.h | 9 +- include/deal.II/multigrid/mg_tools.h | 6 +- include/deal.II/numerics/data_out_rotation.h | 4 +- include/deal.II/numerics/error_estimator.h | 4 +- include/deal.II/numerics/fe_field_function.h | 54 ++++-- .../deal.II/numerics/point_value_history.h | 14 +- include/deal.II/numerics/vector_tools.h | 101 +++++++---- 98 files changed, 1192 insertions(+), 531 deletions(-) diff --git a/include/deal.II/base/derivative_form.h b/include/deal.II/base/derivative_form.h index 792692f972..edfe8ed62c 100644 --- a/include/deal.II/base/derivative_form.h +++ b/include/deal.II/base/derivative_form.h @@ -383,6 +383,7 @@ DerivativeForm::memory_consumption () * One of the uses of DerivativeForm is to apply it as a transformation. This * is what this function does. If @p T is DerivativeForm<1,dim,1> it computes * $DF * T$, if @p T is DerivativeForm<1,dim,rank> it computes $T*DF^{t}$. + * * @relates DerivativeForm * @author Sebastian Pauletti, 2011 */ @@ -402,6 +403,7 @@ apply_transformation (const DerivativeForm<1,dim,spacedim> &DF, /** * Similar to previous apply_transformation. It computes $T*DF^{t}$. + * * @relates DerivativeForm * @author Sebastian Pauletti, 2011 */ @@ -422,6 +424,7 @@ apply_transformation (const DerivativeForm<1,dim,spacedim> &DF, /** * Similar to previous apply_transformation. It computes $DF2*DF1^{t}$ + * * @relates DerivativeForm * @author Sebastian Pauletti, 2011 */ @@ -442,7 +445,9 @@ apply_transformation (const DerivativeForm<1,dim,spacedim> &DF1, /** * Transpose of a rectangular DerivativeForm DF, mostly for compatibility - * reasons. @relates DerivativeForm + * reasons. + * + * @relates DerivativeForm * @author Sebastian Pauletti, 2011 */ template diff --git a/include/deal.II/base/exceptions.h b/include/deal.II/base/exceptions.h index 62642a789b..765a630b80 100644 --- a/include/deal.II/base/exceptions.h +++ b/include/deal.II/base/exceptions.h @@ -31,7 +31,9 @@ DEAL_II_NAMESPACE_OPEN * subject to change. Rather create new exception classes using the * DeclException macro family. * - * See the @ref Exceptions module for more details on this class and what can + * See the + * @ref Exceptions + * module for more details on this class and what can * be done with classes derived from it. * * @ingroup Exceptions diff --git a/include/deal.II/base/function.h b/include/deal.II/base/function.h index 4d62a580f4..378bdda829 100644 --- a/include/deal.II/base/function.h +++ b/include/deal.II/base/function.h @@ -428,7 +428,9 @@ protected: * VectorTools::integrate_difference, where it allows to integrate only one or * a few vector components, rather than the entire vector-valued solution. In * other words, it acts as a component mask with a single component selected - * (see the @ref GlossComponentMask "the glossary entry on component masks"). + * (see the + * @ref GlossComponentMask "the glossary entry on component masks" + * ). * See the step-20 tutorial program for a detailed explanation and a use case. * * @ingroup functions diff --git a/include/deal.II/base/geometry_info.h b/include/deal.II/base/geometry_info.h index 597acce741..a883e846ef 100644 --- a/include/deal.II/base/geometry_info.h +++ b/include/deal.II/base/geometry_info.h @@ -1098,7 +1098,9 @@ struct GeometryInfo<0> * places in application programs where you need this information actually, * but a few places in the library make use of this. Note that in 2d, the * result is always @p true. More information on the topic can be found in - * this @ref GlossFaceOrientation "glossary" article. + * this + * @ref GlossFaceOrientation "glossary" + * article. * * In order to allow all kinds of meshes in 3d, including * Moebius-loops, a face might even be rotated looking from one cell, @@ -1112,8 +1114,8 @@ struct GeometryInfo<0> * This information is available as the line_orientation flag for * cells and faces in 3d. Again, this is something that should be internal to * the library and application program will probably never have to bother - * about it. For more information on this see also @ref GlossFaceOrientation - * "this glossary entry" . + * about it. For more information on this see also + * @ref GlossFaceOrientation "this glossary entry". * * *

Children

@@ -1303,7 +1305,8 @@ struct GeometryInfo<0> * * @note Instantiations for this template are provided for dimensions 1,2,3,4, * and there is a specialization for dim=0 (see the section on - * @ref Instantiations in the manual). + * @ref Instantiations + * in the manual). * * @ingroup grid geomprimitives aniso * @author Wolfgang Bangerth, 1998, Ralf Hartmann, 2005, Tobias Leicht, 2007 @@ -1546,7 +1549,8 @@ struct GeometryInfo * defaults to true, face_flip and face_rotation * default to false (standard orientation) and has no effect in 2d. * The concept of face orientations is explained in this - * @ref GlossFaceOrientation "glossary" entry. + * @ref GlossFaceOrientation "glossary" + * entry. * * In the case of anisotropically refined cells and faces, the @p * RefinementCase of the face, face_ref_case, might have an @@ -1593,8 +1597,9 @@ struct GeometryInfo * the standard and non-standard orientation. face_orientation * defaults to true, face_flip and face_rotation * default to false (standard orientation). In 2d only - * face_flip is considered. See this @ref GlossFaceOrientation - * "glossary" article for more information. + * face_flip is considered. See this + * @ref GlossFaceOrientation "glossary" + * article for more information. * * As the children of a cell are ordered according to the vertices of the * cell, this call is passed down to the child_cell_on_face() function. @@ -1846,7 +1851,9 @@ struct GeometryInfo * tangential to the quad mapped into three-dimensional space. * * This function is used in order to determine how distorted a cell is (see - * the entry on @ref GlossDistorted "distorted cells" in the glossary). + * the entry on + * @ref GlossDistorted "distorted cells" + * in the glossary). */ template static void @@ -1883,7 +1890,8 @@ struct GeometryInfo * least in 3d, actual faces of cells in a triangulation can also have the * opposite orientation, depending on a flag that one can query from the * cell it belongs to. For more information, see the - * @ref GlossFaceOrientation "glossary" entry on face orientation. + * @ref GlossFaceOrientation "glossary" + * entry on face orientation. */ static const int unit_normal_orientation[faces_per_cell]; diff --git a/include/deal.II/base/graph_coloring.h b/include/deal.II/base/graph_coloring.h index fa68060fc0..c097741873 100644 --- a/include/deal.II/base/graph_coloring.h +++ b/include/deal.II/base/graph_coloring.h @@ -492,7 +492,8 @@ namespace GraphColoring * color. * * @note The algorithm used in this function is described in a paper by - * Turcksin, Kronbichler and Bangerth, see @ref workstream_paper . + * Turcksin, Kronbichler and Bangerth, see + * @ref workstream_paper. * * @param[in] begin The first element of a range of iterators for which a * coloring is sought. diff --git a/include/deal.II/base/index_set.h b/include/deal.II/base/index_set.h index cab8e7081d..4061ecd74d 100644 --- a/include/deal.II/base/index_set.h +++ b/include/deal.II/base/index_set.h @@ -51,7 +51,8 @@ DEAL_II_NAMESPACE_OPEN * class are a subset. * * The data structures used in this class along with a rationale can be found - * in the @ref distributed_paper "Distributed Computing paper". + * in the + * @ref distributed_paper "Distributed Computing paper". * * @author Wolfgang Bangerth, 2009 */ diff --git a/include/deal.II/base/iterator_range.h b/include/deal.II/base/iterator_range.h index bad89e2038..914db74eb0 100644 --- a/include/deal.II/base/iterator_range.h +++ b/include/deal.II/base/iterator_range.h @@ -35,7 +35,8 @@ DEAL_II_NAMESPACE_OPEN * DoFHandler can return ranges of cell iterators using an object of the * current type from functions such as Triangulation::cells() and that such an * object can then be used in a range-based for loop as supported by C++11, - * see also @ref CPP11 "C++11 standard". + * see also + * @ref CPP11 "C++11 standard". * * For example, such a loop could look like this if the goal is to set the * user flag on every active cell: diff --git a/include/deal.II/base/multithread_info.h b/include/deal.II/base/multithread_info.h index 165e63f277..b54e480587 100644 --- a/include/deal.II/base/multithread_info.h +++ b/include/deal.II/base/multithread_info.h @@ -29,10 +29,14 @@ DEAL_II_NAMESPACE_OPEN * multithreaded programs. At the moment this is just the number of CPUs. If * deal.II is compiled with multithreading support, some functions will use * multiple threads for their action. Currently the library supports both - * thread-based and task-based parallelism. @ref threads describes the + * thread-based and task-based parallelism. + * @ref threads + * describes the * different uses of each. The default number of threads used for task-based * parallel methods is selected automatically by the Threading Building Blocks - * library. See @ref threads for more information on this. Thread-based + * library. See + * @ref threads + * for more information on this. Thread-based * parallel methods need to explicitly created threads and may want to use a * number of threads that is related to the number of CPUs in your system. * This can be queried using the variable multithread_info.n_cpus; diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index 250be624d2..365359474d 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -187,14 +187,16 @@ namespace Patterns private: /** - * Value of the lower bound. A number that satisfies the @ref match + * Value of the lower bound. A number that satisfies the + * @ref match * operation of this class must be equal to this value or larger, if the * bounds of the interval for a valid range. */ const int lower_bound; /** - * Value of the upper bound. A number that satisfies the @ref match + * Value of the upper bound. A number that satisfies the + * @ref match * operation of this class must be equal to this value or less, if the * bounds of the interval for a valid range. */ @@ -279,14 +281,16 @@ namespace Patterns private: /** - * Value of the lower bound. A number that satisfies the @ref match + * Value of the lower bound. A number that satisfies the + * @ref match * operation of this class must be equal to this value or larger, if the * bounds of the interval for a valid range. */ const double lower_bound; /** - * Value of the upper bound. A number that satisfies the @ref match + * Value of the upper bound. A number that satisfies the + * @ref match * operation of this class must be equal to this value or less, if the * bounds of the interval for a valid range. */ @@ -301,7 +305,9 @@ namespace Patterns /** * Test for the string being one of a sequence of values given like a * regular expression. For example, if the string given to the constructor - * is "red|blue|black", then the @ref match function returns + * is "red|blue|black", then the + * @ref match + * function returns * true exactly if the string is either "red" or "blue" or "black". * Spaces around the pipe signs do not matter and are eliminated. */ @@ -885,8 +891,9 @@ namespace Patterns * Input may be sorted into subsection trees in order to give the input a * logical structure, and input files may include other files. * - * The ParameterHandler class is discussed in detail in the @ref step_19 - * "step-19" example program, and is used in more realistic situations in + * The ParameterHandler class is discussed in detail in the + * @ref step_19 "step-19" + * example program, and is used in more realistic situations in * step-29, step-33 and step-34. * *

Declaring entries

diff --git a/include/deal.II/base/qprojector.h b/include/deal.II/base/qprojector.h index 18d399338c..e2d699310d 100644 --- a/include/deal.II/base/qprojector.h +++ b/include/deal.II/base/qprojector.h @@ -63,8 +63,9 @@ DEAL_II_NAMESPACE_OPEN * cell->face_orientation(face)), so we have to project quadrature * formula onto faces and subfaces in two orientations. (Refer to the * documentation of the Triangulation class for a description of the - * orientation of the different faces, as well as to @ref GlossFaceOrientation - * "the glossary entry on face orientation" for more information on this.) The + * orientation of the different faces, as well as to + * @ref GlossFaceOrientation "the glossary entry on face orientation" + * for more information on this.) The * DataSetDescriptor member class is used to identify where each dataset * starts. * diff --git a/include/deal.II/base/quadrature.h b/include/deal.II/base/quadrature.h index 52829c729c..4e29ae4493 100644 --- a/include/deal.II/base/quadrature.h +++ b/include/deal.II/base/quadrature.h @@ -72,7 +72,9 @@ DEAL_II_NAMESPACE_OPEN * N is the constructor parameter of QGauss. * * @note Instantiations for this template are provided for dimensions 0, 1, 2, - * and 3 (see the section on @ref Instantiations). + * and 3 (see the section on + * @ref Instantiations + * ). * * @author Wolfgang Bangerth, Guido Kanschat, 1998, 1999, 2000, 2005, 2009 */ diff --git a/include/deal.II/base/types.h b/include/deal.II/base/types.h index 9e3bdb09d4..54fd11fda7 100644 --- a/include/deal.II/base/types.h +++ b/include/deal.II/base/types.h @@ -30,7 +30,9 @@ namespace types /** * The type used to denote subdomain_ids of cells. * - * See the @ref GlossSubdomainId "glossary" for more information. + * See the + * @ref GlossSubdomainId "glossary" + * for more information. * * There is a special value, numbers::invalid_subdomain_id that is used to * indicate an invalid value of this type. @@ -62,7 +64,9 @@ namespace types * * The data type always indicates an unsigned integer type. * - * See the @ref GlobalDoFIndex page for guidance on when this type should or + * See the + * @ref GlobalDoFIndex + * page for guidance on when this type should or * should not be used. */ // TODO: we should check that unsigned long long int @@ -109,7 +113,8 @@ namespace types * boundary indicator for faces that are in the interior of the domain and * therefore not part of any addressable boundary component. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ typedef unsigned char boundary_id; @@ -120,7 +125,8 @@ namespace types * There is a special value, numbers::flat_manifold_id that is used to * indicate the standard cartesian manifold. * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ typedef unsigned int manifold_id; @@ -204,7 +210,8 @@ namespace numbers * We assume that all valid boundary_ids lie in the range [0, * invalid_boundary_id). * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ const types::boundary_id invalid_boundary_id = static_cast(-1); @@ -218,7 +225,8 @@ namespace numbers * faces that lie in the interior of the domain. You should never try to * assign this boundary indicator to anything in user code. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ const types::boundary_id internal_face_boundary_id = static_cast(-1); @@ -227,14 +235,16 @@ namespace numbers * We assume that all valid manifold_ids lie in the range [0, * invalid_maifold_id). * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ const types::manifold_id invalid_manifold_id = static_cast(-1); /** * A manifold_id we reserve for the default flat Cartesian manifold. * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ const types::manifold_id flat_manifold_id = static_cast(-1); @@ -243,7 +253,9 @@ namespace numbers * valid id but is used, for example, for default arguments to indicate a * subdomain id that is not to be used. * - * See the @ref GlossSubdomainId "glossary" for more information. + * See the + * @ref GlossSubdomainId "glossary" + * for more information. */ const types::subdomain_id invalid_subdomain_id = static_cast(-1); @@ -253,9 +265,13 @@ namespace numbers * that is kept distributed on many processors. Such cells are called * "artificial". * - * See the glossary entries on @ref GlossSubdomainId "subdomain ids" and - * @ref GlossArtificialCell "artificial cells" as well as the - * @ref distributed module for more information. + * See the glossary entries on + * @ref GlossSubdomainId "subdomain ids" + * and + * @ref GlossArtificialCell "artificial cells" + * as well as the + * @ref distributed + * module for more information. */ const types::subdomain_id artificial_subdomain_id = static_cast(-2); } diff --git a/include/deal.II/base/work_stream.h b/include/deal.II/base/work_stream.h index ee63fab329..ad57d94635 100644 --- a/include/deal.II/base/work_stream.h +++ b/include/deal.II/base/work_stream.h @@ -47,7 +47,8 @@ DEAL_II_NAMESPACE_OPEN * uses the Intel Threading Building Blocks (TBB) to load balance the * individual subranges onto the available threads. For a lengthy discussion * of the rationale of this class, see the - * @ref threads "Parallel computing with multiple processors" module. It is + * @ref threads "Parallel computing with multiple processors" + * module. It is * used in the tutorial first in step-9, and again in step-13, step-14, * step-32 and others. * @@ -150,7 +151,9 @@ namespace WorkStream * A namespace for the implementation of details of the WorkStream pattern * and function. This namespace holds classes that deal with the second * implementation described in the paper by Turcksin, Kronbichler and - * Bangerth (see @ref workstream_paper). + * Bangerth (see + * @ref workstream_paper + * ). * * Even though this implementation is slower than the third implementation * discussed in that paper, we need to keep it around for two reasons: (i) @@ -700,7 +703,9 @@ namespace WorkStream * A namespace for the implementation of details of the WorkStream pattern * and function. This namespace holds classes that deal with the third * implementation described in the paper by Turcksin, Kronbichler and - * Bangerth (see @ref workstream_paper). + * Bangerth (see + * @ref workstream_paper + * ). */ namespace Implementation3 { @@ -917,7 +922,8 @@ namespace WorkStream * This is one of two main functions of the WorkStream concept, doing work * as described in the introduction to this namespace. It corresponds to * implementation 3 of the paper by Turcksin, Kronbichler and Bangerth, see - * @ref workstream_paper . As such, it takes not a range of iterators + * @ref workstream_paper. + * As such, it takes not a range of iterators * described by a begin and end iterator, but a "colored" graph of iterators * where each color represents cells for which writing the cell * contributions into the global object does not conflict (in other words, @@ -966,7 +972,8 @@ namespace WorkStream * This is one of two main functions of the WorkStream concept, doing work * as described in the introduction to this namespace. It corresponds to * implementation 2 of the paper by Turcksin, Kronbichler and Bangerth (see - * @ref workstream_paper). + * @ref workstream_paper + * ). * * This function that can be used for worker and copier objects that are * either pointers to non-member functions or objects that allow to be @@ -1195,7 +1202,9 @@ namespace WorkStream * This is a variant of one of the two main functions of the WorkStream * concept, doing work as described in the introduction to this namespace. * It corresponds to implementation 2 of the paper by Turcksin, Kronbichler - * and Bangerth (see @ref workstream_paper). + * and Bangerth (see + * @ref workstream_paper + * ). * * This is the function that can be used for worker and copier functions * that are member functions of a class. If the copier is an empty function, diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 680eb6eea2..3733a9aed5 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -172,10 +172,13 @@ namespace parallel * dealii::Triangulation class but there are a number of difficult * algorithms under the hood that ensure we always have a load-balanced, * fully distributed mesh. Use of this class is explained in step-40, - * step-32, the @ref distributed documentation module, as well as the - * @ref distributed_paper . See there for more information. This class - * satisfies the requirements outlined in @ref GlossMeshAsAContainer - * "Meshes as containers". + * step-32, the + * @ref distributed + * documentation module, as well as the + * @ref distributed_paper. + * See there for more information. This class + * satisfies the requirements outlined in + * @ref GlossMeshAsAContainer "Meshes as containers". * * @note This class does not support anisotropic refinement, because it * relies on the p4est library that does not support this. Attempts to @@ -191,8 +194,10 @@ namespace parallel * mesh that we want to store here from what we have stored before * therefore may involve several cycles of refining and coarsening the * locally stored set of cells until we have finally gotten from the - * previous to the next triangulation. (This process is described in more - * detail in the @ref distributed_paper.) Unfortunately, in this process, + * previous to the next triangulation. This process is described in more + * detail in the + * @ref distributed_paper. + * Unfortunately, in this process, * some information can get lost relating to flags that are set by user * code and that are inherited from mother to child cell but that are not * moved along with a cell if that cell is migrated from one processor to @@ -344,7 +349,8 @@ namespace parallel /** * A typedef that is used to to identify - * @ref GlossActive "active cell iterators". The concept of iterators + * @ref GlossActive "active cell iterators". + * The concept of iterators * is discussed at length in the * @ref Iterators "iterators documentation module". * @@ -540,7 +546,9 @@ namespace parallel * As a consequence of the remark above, the result of this function is * always smaller or equal to the result of the function with the same * name in the ::Triangulation base class, which includes the active - * ghost and artificial cells (see also @ref GlossArtificialCell and + * ghost and artificial cells (see also + * @ref GlossArtificialCell + * and * @ref GlossGhostCell). */ unsigned int n_locally_owned_active_cells () const; @@ -570,7 +578,9 @@ namespace parallel * 2:1 relationship between cells, this may mean that there are hanging * nodes between cells that are not locally owned or ghost cells (i.e., * between ghost cells and artificial cells, or between artificial and - * artificial cells; see @ref GlossArtificialCell "the glossary"). One + * artificial cells; see + * @ref GlossArtificialCell "the glossary" + * ). One * is not typically interested in this case, so the function returns * whether there are hanging nodes between any two cells of the "global" * mesh, i.e., the union of locally owned cells on all processors. diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index abd63aca1c..33ebd56a74 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, * MGSoDHandler, 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. + * concept is 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 @@ -330,7 +331,9 @@ public: * this object in the standard ordering defined by the finite element (i.e., * dofs on vertex 0, dofs on vertex 1, etc, dofs on line 0, dofs on line 1, * etc, dofs on quad 0, etc.) This function is only available on - * active objects (see @ref GlossActive "this glossary entry"). + * active objects (see + * @ref GlossActive "this glossary entry" + * ). * * The cells needs to be an active cell (and not artificial in a parallel * distributed computation). @@ -526,8 +529,9 @@ public: */ DeclException0 (ExcMatrixDoesNotMatch); /** - * A function has been called for a cell which should be active, but is - * refined. @ref GlossActive + * A function has been called for a cell which should be + * @ref GlossActive "active" + * , but is refined. * * @ingroup Exceptions */ @@ -832,7 +836,9 @@ public: * this object in the standard ordering defined by the finite element (i.e., * dofs on vertex 0, dofs on vertex 1, etc, dofs on line 0, dofs on line 1, * etc, dofs on quad 0, etc.) This function is only available on - * active objects (see @ref GlossActive "this glossary entry"). + * active objects (see + * @ref GlossActive "this glossary entry" + * ). * * The cells needs to be an active cell (and not artificial in a parallel * distributed computation). @@ -995,8 +1001,9 @@ public: */ DeclException0 (ExcMatrixDoesNotMatch); /** - * A function has been called for a cell which should be active, but is - * refined. @ref GlossActive + * A function has been called for a cell which should be + * @ref GlossActive "active" + * , but is refined. * * @ingroup Exceptions */ @@ -1531,7 +1538,9 @@ public: * this object in the standard ordering defined by the finite element (i.e., * dofs on vertex 0, dofs on vertex 1, etc, dofs on line 0, dofs on line 1, * etc, dofs on quad 0, etc.) This function is only available on - * active objects (see @ref GlossActive "this glossary entry"). + * active objects (see + * @ref GlossActive "this glossary entry" + * ). * * @param[out] dof_indices The vector into which the indices will be * written. It has to have the right size (namely, diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index a666adfe3a..0fd4c2249e 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -67,7 +67,8 @@ namespace internal /** * Manage the distribution and numbering of the degrees of freedom for non- * multigrid algorithms. This class satisfies the requirements outlined in - * @ref GlossMeshAsAContainer "Meshes as containers". It is first used in the + * @ref GlossMeshAsAContainer "Meshes as containers". + * It is first used in the * step-2 tutorial program. * * For each vertex, line, quad, etc, this class stores a list of the indices @@ -126,7 +127,9 @@ namespace internal * i.e. the class that represents triangulations that entirely reside on a * single processor. However, it can also be of type * parallel::distributed::Triangulation (see, for example, step-32, step-40 - * and in particular the @ref distributed module) in which case the DoFHandler + * and in particular the + * @ref distributed + * module) in which case the DoFHandler * object will proceed to only manage degrees of freedom on locally owned and * ghost cells. This process is entirely transparent to the used. * @@ -223,7 +226,8 @@ public: * * The current typedef identifies cells in a DoFHandler object. Some of * these cells may in fact be active (see - * @ref GlossActive "active cell iterators") in which case they can in + * @ref GlossActive "active cell iterators" + * ) in which case they can in * fact be asked for the degrees of freedom that live on them. On the * other hand, if the cell is not active, any such query will result in * an error. Note that this is what distinguishes this typedef from the @@ -448,7 +452,8 @@ public: * use an intermediate compressed sparsity pattern that only allocates * memory on demand. Refer to the step-2 and step-11 example programs on how * to do this. The problem is also discussed in the documentation of the - * module on @ref Sparsity. + * module on + * @ref Sparsity. */ unsigned int max_couplings_between_dofs () const; @@ -461,7 +466,9 @@ public: * * @note The same applies to this function as to max_couplings_per_dofs() as * regards the performance of this function. Think about one of the dynamic - * sparsity pattern classes instead (see @ref Sparsity). + * sparsity pattern classes instead (see + * @ref Sparsity + * ). */ unsigned int max_couplings_between_boundary_dofs () const; @@ -551,7 +558,8 @@ public: /** * Return an iterator range that contains all active cells that make up this * DoFHandler. Such a range is useful to initialize range-based for loops as - * supported by C++11, see also @ref CPP11 "C++11 standard". + * supported by C++11, see also + * @ref CPP11 "C++11 standard". * * Range-based for loops are useful in that they require much less code than * traditional loops (see , only the treatment of - * templates is a little more complicated. See the @ref Iterators module + * templates is a little more complicated. See the + * @ref Iterators + * module * for more information. * * @author Wolfgang Bangerth, Oliver Kayser-Herold, Guido Kanschat, 1998, @@ -89,8 +91,9 @@ namespace internal * * The types have the same meaning as those declared in * internal::Triangulation::Iterators<2,spacedim>, only the treatment of - * templates is a little more complicated. See the @ref Iterators module - * for more information. + * templates is a little more complicated. See the + * @ref Iterators + * module for more information. * * @author Wolfgang Bangerth, Oliver Kayser-Herold, Guido Kanschat, 1998, * 2003, 2008, 2010 @@ -131,8 +134,9 @@ namespace internal * * The types have the same meaning as those declared in * internal::Triangulation::Iterators<3,spacedim>, only the treatment of - * templates is a little more complicated. See the @ref Iterators module - * for more information. + * templates is a little more complicated. See the + * @ref Iterators + * module for more information. * * @author Wolfgang Bangerth, Oliver Kayser-Herold, Guido Kanschat, 1998, * 2003, 2008, 2010 diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index 908856f13d..61e9709403 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -163,8 +163,11 @@ DEAL_II_NAMESPACE_OPEN * The component_wise() function allows not only to honor enumeration based on * vector components, but also allows to group together vector components into * "blocks" using a defaulted argument to the various - * DoFRenumber::component_wise() functions (see @ref GlossComponent vs - * @ref GlossBlock for a description of the difference). The blocks designated + * DoFRenumber::component_wise() functions (see + * @ref GlossComponent + * vs + * @ref GlossBlock + * for a description of the difference). The blocks designated * through this argument may, but do not have to be, equal to the blocks that * the finite element reports. For example, a typical Stokes element would be * @code @@ -684,7 +687,9 @@ namespace DoFRenumbering * * This function only succeeds if each of the elements in the * hp::FECollection attached to the hp::DoFHandler argument has exactly the - * same number of blocks (see @ref GlossBlock "the glossary" for more + * same number of blocks (see + * @ref GlossBlock "the glossary" + * for more * information). Note that this is not always given: while the * hp::FECollection class ensures that all of its elements have the same * number of vector components, they need not have the same number of diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index b58895a56b..04ffebd007 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -469,7 +469,9 @@ namespace DoFTools * into account at the time of creating the sparsity pattern. For this, pass * the ConstraintMatrix object as the third argument to the current * function. No call to ConstraintMatrix::condense() is then necessary. This - * process is explained in @ref step_27 "step-27". + * process is explained in + * @ref step_27 "step-27" +. * * In case the constraints are already taken care of in this function, it is * possible to neglect off-diagonal entries in the sparsity pattern. When @@ -646,7 +648,9 @@ namespace DoFTools * The object into which these are inserted is later used to condense the * global system matrix and right hand side, and to extend the solution * vectors from the true degrees of freedom also to the constraint nodes. - * This function is explained in detail in the @ref step_6 "step-6" tutorial + * This function is explained in detail in the + * @ref step_6 "step-6" + * tutorial * program and is used in almost all following programs as well. * * This function does not clear the constraint matrix object before use, in @@ -812,7 +816,9 @@ namespace DoFTools * (dofs the entry is constrained to, inhomogeneities) is kept and nothing * happens. * - * The flags in the @p component_mask (see @ref GlossComponentMask) denote + * The flags in the @p component_mask (see + * @ref GlossComponentMask + * ) denote * which components of the finite element space shall be constrained with * periodic boundary conditions. If it is left as specified by the default * value all components are constrained. If it is different from the default @@ -959,7 +965,8 @@ namespace DoFTools * parallel::distributed::Triangulation::add_periodicity has to be called * before. * - * @see @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" + * @see + * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" * for further information. * * @author Daniel Arndt, Matthias Maier, 2013, 2014 @@ -1000,7 +1007,8 @@ namespace DoFTools * happens. * * The flags in the last parameter, @p component_mask (see - * @ref GlossComponentMask) denote which components of the finite element space + * @ref GlossComponentMask + * ) denote which components of the finite element space * shall be constrained with periodic boundary conditions. If it is left as * specified by the default value all components are constrained. If it is * different from the default value, it is assumed that the number of @@ -1013,7 +1021,8 @@ namespace DoFTools * feeds the output to above make_periodicity_constraints() variant. If you * need more functionality use GridTools::collect_periodic_faces() directly. * - * @see @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" + * @see + * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" * for further information. * * @author Matthias Maier, 2012 @@ -1032,7 +1041,8 @@ namespace DoFTools /** * This compatibility version of make_periodicity_constraints only works on - * grids with cells in @ref GlossFaceOrientation "standard orientation". + * grids with cells in + * @ref GlossFaceOrientation "standard orientation". * * Instead of defining a 'first' and 'second' boundary with the help of two * boundary_indicators this function defines a 'left' boundary as all faces @@ -1049,7 +1059,8 @@ namespace DoFTools * feeds the output to above make_periodicity_constraints() variant. If you * need more functionality use GridTools::collect_periodic_faces() directly. * - * @see @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" + * @see + * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" * for further information. */ template @@ -1176,7 +1187,9 @@ namespace DoFTools * (which holds, for example, for FE_Nedelec or FE_RaviartThomas elements), * then shape functions cannot be associated with a single vector component. * In this case, if one shape vector component of this element is - * flagged in @p component_mask (see @ref GlossComponentMask), then this is + * flagged in @p component_mask (see + * @ref GlossComponentMask + * ), then this is * equivalent to selecting all vector components corresponding to * this non-primitive base element. * @@ -1200,15 +1213,20 @@ namespace DoFTools /** * This function is the equivalent to the DoFTools::extract_dofs() functions * above except that the selection of which degrees of freedom to extract is - * not done based on components (see @ref GlossComponent) but instead based - * on whether they are part of a particular block (see @ref GlossBlock). - * Consequently, the second argument is not a ComponentMask but a BlockMask + * not done based on components (see + * @ref GlossComponent + * ) but instead based + * on whether they are part of a particular block (see + * @ref GlossBlock + * ). Consequently, the second argument is not a ComponentMask but a BlockMask * object. * * @param dof_handler The DoFHandler object from which to extract degrees of * freedom * @param block_mask The block mask that describes which blocks to consider - * (see @ref GlossBlockMask) + * (see + * @ref GlossBlockMask + * ) * @param selected_dofs A vector of length DoFHandler::n_dofs() in which * those entries are true that correspond to the selected blocks. */ @@ -1261,7 +1279,9 @@ namespace DoFTools * freedom are located that shall be extracted. If it is an empty list, then * all boundary indicators are accepted. * - * The size of @p component_mask (see @ref GlossComponentMask) shall equal + * The size of @p component_mask (see + * @ref GlossComponentMask + * ) shall equal * the number of components in the finite element used by @p dof. The size * of @p selected_dofs shall equal dof_handler.n_dofs(). Previous * contents of this array or overwritten. @@ -1282,7 +1302,9 @@ namespace DoFTools * @param dof_handler The object that describes which degrees of freedom * live on which cell * @param component_mask A mask denoting the vector components of the finite - * element that should be considered (see also @ref GlossComponentMask). + * element that should be considered (see also + * @ref GlossComponentMask + * ). * @param selected_dofs The IndexSet object that is returned and that will * contain the indices of degrees of freedom that are located on the * boundary (and correspond to the selected vector components and boundary @@ -1293,7 +1315,8 @@ namespace DoFTools * empty list, then the function only considers boundary faces with the * boundary indicators listed in this argument. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -1312,12 +1335,15 @@ namespace DoFTools * parallel::distributed::Triangulation, then the @p selected_dofs index set * will contain only those degrees of freedom on the boundary that belong to * the locally relevant set (see - * @ref GlossLocallyRelevantDof "locally relevant DoFs"). + * @ref GlossLocallyRelevantDof "locally relevant DoFs" + * ). * * @param dof_handler The object that describes which degrees of freedom * live on which cell * @param component_mask A mask denoting the vector components of the finite - * element that should be considered (see also @ref GlossComponentMask). + * element that should be considered (see also + * @ref GlossComponentMask + * ). * @param selected_dofs The IndexSet object that is returned and that will * contain the indices of degrees of freedom that are located on the * boundary (and correspond to the selected vector components and boundary @@ -1328,7 +1354,8 @@ namespace DoFTools * empty list, then the function only considers boundary faces with the * boundary indicators listed in this argument. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -1350,7 +1377,8 @@ namespace DoFTools * the FiniteElement::has_support_on_face function says that it is nonzero * on any face on one of the selected boundary parts. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -1362,7 +1390,8 @@ namespace DoFTools /** * Extract a vector that represents the constant modes of the DoFHandler for * the components chosen by component_mask (see - * @ref GlossComponentMask). + * @ref GlossComponentMask + * ). * The constant modes on a discretization are the null * space of a Laplace operator on the selected components with Neumann * boundary conditions applied. The null space is a necessary ingredient for @@ -1375,7 +1404,9 @@ namespace DoFTools * space (or rather, the constant modes) is provided by the finite element * underlying the given DoFHandler and for most elements, the null space * will consist of as many vectors as there are true arguments in - * component_mask (see @ref GlossComponentMask), each of which will + * component_mask (see + * @ref GlossComponentMask + * ), each of which will * be one in one vector component and zero in all others. However, the * representation of the constant function for e.g. FE_DGP is different (the * first component on each element one, all other components zero), and some @@ -1458,7 +1489,8 @@ namespace DoFTools * indices that live on all locally owned cells (including on the interface * to ghost cells). However, it does not contain the DoF indices that are * exclusively defined on ghost or artificial cells (see - * @ref GlossArtificialCell "the glossary"). + * @ref GlossArtificialCell "the glossary" + * ). * * The degrees of freedom identified by this function equal those obtained * from the dof_indices_with_subdomain_association() function when called @@ -1475,7 +1507,9 @@ namespace DoFTools * DoFHandler objects built on parallel::distributed::Triangulation this set * is the union of DoFHandler::locally_owned_dofs() and the DoF indices on * all ghost cells. In essence, it is the DoF indices on all cells that are - * not artificial (see @ref GlossArtificialCell "the glossary"). + * not artificial (see + * @ref GlossArtificialCell "the glossary" + * ). */ template void @@ -1794,7 +1828,9 @@ namespace DoFTools /** * Count the degrees of freedom in each block. This function is similar to * count_dofs_per_component(), with the difference that the counting is done - * by blocks. See @ref GlossBlock "blocks" in the glossary for details. + * by blocks. See + * @ref GlossBlock "blocks" + * in the glossary for details. * Again the vectors are assumed to have the correct size before calling * this function. If this is not the case, an assertion is thrown. * @@ -1955,7 +1991,8 @@ namespace DoFTools * * See the general doc of this class for more information. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -1965,7 +2002,8 @@ namespace DoFTools /** * Return a list of support points (see this - * @ref GlossSupport "glossary entry") for all the degrees of freedom + * @ref GlossSupport "glossary entry" + * ) for all the degrees of freedom * handled by this DoF handler object. This function, of course, only * works if the finite element object used by the DoF handler object * actually provides support points, i.e. no edge elements or the like. @@ -1999,7 +2037,8 @@ namespace DoFTools /** * This function is a version of the above map_dofs_to_support_points * function that doesn't simply return a vector of support points (see this - * @ref GlossSupport "glossary entry") with one entry for each global degree + * @ref GlossSupport "glossary entry" + * ) with one entry for each global degree * of freedom, but instead a map that maps from the DoFs index to its * location. The point of this function is that it is also usable in cases * where the DoFHandler is based on a parallel::distributed::Triangulation @@ -2009,8 +2048,8 @@ namespace DoFTools * were known. As a consequence, this function constructs a map from those * DoFs for which we can know the locations (namely, those DoFs that are * locally relevant (see - * @ref GlossLocallyRelevantDof "locally relevant DoFs") to their - * locations. + * @ref GlossLocallyRelevantDof "locally relevant DoFs" + * ) to their locations. * * For non-distributed triangulations, the map returned as @p support_points * is of course dense, i.e., every DoF is to be found in it. @@ -2096,21 +2135,27 @@ namespace DoFTools * object consists of constraints on degrees of freedom that are not located * on the boundary treated here. If there are previously existing * constraints for degrees of freedom located on the boundary, then this - * would constitute a conflict. See the @ref constraints module for handling + * would constitute a conflict. See the + * @ref constraints + * module for handling * the case where there are conflicting constraints on individual degrees of * freedom. * @param component_mask An optional component mask that restricts the * functionality of this function to a subset of an FESystem. For - * non-@ref GlossPrimitive "primitive" shape functions, any degree of freedom + * non- + * @ref GlossPrimitive "primitive" + * shape functions, any degree of freedom * is affected that belongs to a shape function where at least one of its * nonzero components is affected by the component mask (see - * @ref GlossComponentMask). If this argument is omitted, all components + * @ref GlossComponentMask + * ). If this argument is omitted, all components * of the finite element with degrees of freedom at the boundary will be * considered. * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template class DH> void diff --git a/include/deal.II/fe/block_mask.h b/include/deal.II/fe/block_mask.h index b036fb954a..ae82b2fc48 100644 --- a/include/deal.II/fe/block_mask.h +++ b/include/deal.II/fe/block_mask.h @@ -30,7 +30,8 @@ DEAL_II_NAMESPACE_OPEN /** * This class represents a mask that can be used to select individual vector * blocks of a finite element (see also - * @ref GlossBlockMask "this glossary entry"). It will typically have as + * @ref GlossBlockMask "this glossary entry" + * ). It will typically have as * many elements as the finite element has blocks, and one can use * operator[] to query whether a particular block has been * selected. @@ -44,7 +45,9 @@ DEAL_II_NAMESPACE_OPEN * These objects can either be created by hand, or, simpler, by asking the * finite element to generate a block mask from certain selected blocks using * code such as this where we create a mask that only denotes the velocity - * block of a Stokes element (see @ref vector_valued): + * block of a Stokes element (see + * @ref vector_valued + * ): * @code * FESystem stokes_fe (FESystem(FE_Q(2), dim), 1, // Q2 element for the velocities * FE_Q(1), 1); // Q1 element for the pressure diff --git a/include/deal.II/fe/component_mask.h b/include/deal.II/fe/component_mask.h index 8b56438084..8797a06bac 100644 --- a/include/deal.II/fe/component_mask.h +++ b/include/deal.II/fe/component_mask.h @@ -30,7 +30,8 @@ DEAL_II_NAMESPACE_OPEN /** * This class represents a mask that can be used to select individual vector * components of a finite element (see also - * @ref GlossComponentMask "this glossary entry"). It will typically have + * @ref GlossComponentMask "this glossary entry" + * ). It will typically have * as many elements as the finite element has vector components, and one * can use operator[] to query whether a particular component * has been selected. @@ -42,7 +43,9 @@ DEAL_II_NAMESPACE_OPEN * created by hand, or, simpler, by asking the finite element to generate a * component mask from certain selected components using code such as this * where we create a mask that only denotes the velocity components of a - * Stokes element (see @ref vector_valued): + * Stokes element (see + * @ref vector_valued + * ): * @code * FESystem stokes_fe (FE_Q(2), dim, // Q2 element for the velocities * FE_Q(1), 1); // Q1 element for the pressure diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index fa61caf638..3a9064a27b 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -75,14 +75,19 @@ namespace hp *

Components and blocks

* * For vector valued elements shape functions may have nonzero entries in one - * or several @ref GlossComponent "components" of the vector valued function. - * If the element is @ref GlossPrimitive "primitive", there is indeed a single + * or several + * @ref GlossComponent "components" + * of the vector valued function. + * If the element is + * @ref GlossPrimitive "primitive" + * , there is indeed a single * component with a nonzero entry for each shape function. This component can * be determined by system_to_component_index(), the number of components is * FiniteElementData::n_components(). * - * Furthermore, you may want to split your linear system into @ref GlossBlock - * "blocks" for the use in BlockVector, BlockSparseMatrix, BlockMatrixArray + * Furthermore, you may want to split your linear system into + * @ref GlossBlock "blocks" + * for the use in BlockVector, BlockSparseMatrix, BlockMatrixArray * and so on. If you use non-primitive elements, you cannot determine the * block number by system_to_component_index(). Instead, you can use * system_to_block_index(), which will automatically take care of the @@ -95,7 +100,9 @@ namespace hp *

Support points

* * Since a FiniteElement does not have information on the actual grid cell, it - * can only provide @ref GlossSupport "support points" on the unit cell. + * can only provide + * @ref GlossSupport "support points" + * on the unit cell. * Support points on the actual grid cell must be computed by mapping these * points. The class used for this kind of operation is FEValues. In most * cases, code of the following type will serve to provide the mapped support @@ -266,7 +273,8 @@ namespace hp * * First, already the basis of the shape function space may be difficult to * implement for arbitrary order and dimension. On the other hand, if the - * @ref GlossNodes "node values" are given, then the duality relation + * @ref GlossNodes "node values" + * are given, then the duality relation * between node functionals and basis functions defines the basis. As a * result, the shape function space may be defined with arbitrary "raw" * basis functions, such that the actual finite element basis is computed @@ -848,7 +856,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination @@ -894,7 +903,8 @@ public: * #system_to_base_table field and the system_to_base_index() function. * * The use of this function is explained extensively in the step-8 and - * @ref step_20 "step-20" tutorial programs as well as in the + * @ref step_20 "step-20" + * tutorial programs as well as in the * @ref vector_valued module. */ std::pair @@ -963,13 +973,17 @@ public: * @param face The number of the face this degree of freedom lives on. This * number must be between zero and GeometryInfo::faces_per_cell. * @param face_orientation One part of the description of the orientation of - * the face. See @ref GlossFaceOrientation . + * the face. See + * @ref GlossFaceOrientation. * @param face_flip One part of the description of the orientation of the - * face. See @ref GlossFaceOrientation . + * face. See + * @ref GlossFaceOrientation. * @param face_rotation One part of the description of the orientation of - * the face. See @ref GlossFaceOrientation . @return The index of this - * degree of freedom within the set of degrees of freedom on the entire - * cell. The returned value will be between zero and dofs_per_cell. + * the face. See + * @ref GlossFaceOrientation. + * @return The index of this degree of freedom within the set of degrees of + * freedom on the entire cell. The returned value will be between zero and + * dofs_per_cell. * * @note This function exists in this class because that is where it was * first implemented. However, it can't really work in the most general case @@ -1018,7 +1032,8 @@ public: * Only for those spaces that couple the components, for example to make a * shape function divergence free, will there be more than one @p true * entry. Elements for which this is true are called non-primitive (see - * @ref GlossPrimitive). + * @ref GlossPrimitive + * ). */ const ComponentMask & get_nonzero_components (const unsigned int i) const; @@ -1170,7 +1185,8 @@ public: * Return a component mask with as many elements as this object has vector * components and of which exactly the one component is true that * corresponds to the given argument. See - * @ref GlossComponentMask "the glossary" for more information. + * @ref GlossComponentMask "the glossary" + * for more information. * * @param scalar An object that represents a single scalar vector component * of this finite element. @return A component mask that is false in all @@ -1183,7 +1199,8 @@ public: * Return a component mask with as many elements as this object has vector * components and of which exactly the dim components are true * that correspond to the given argument. See - * @ref GlossComponentMask "the glossary" for more information. + * @ref GlossComponentMask "the glossary" + * for more information. * * @param vector An object that represents dim vector components of this * finite element. @return A component mask that is false in all components @@ -1196,7 +1213,8 @@ public: * Return a component mask with as many elements as this object has vector * components and of which exactly the dim*(dim+1)/2 components * are true that correspond to the given argument. See - * @ref GlossComponentMask "the glossary" for more information. + * @ref GlossComponentMask "the glossary" + * for more information. * * @param sym_tensor An object that represents dim*(dim+1)/2 components of * this finite element that are jointly to be interpreted as forming a @@ -1207,9 +1225,12 @@ public: component_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const; /** - * Given a block mask (see @ref GlossBlockMask "this glossary entry"), + * Given a block mask (see + * @ref GlossBlockMask "this glossary entry" + * ), * produce a component mask (see - * @ref GlossComponentMask "this glossary entry") that represents the + * @ref GlossComponentMask "this glossary entry" + * ) that represents the * components that correspond to the blocks selected in the input * argument. This is essentially a conversion operator from BlockMask to * ComponentMask. @@ -1224,7 +1245,9 @@ public: /** * Return a block mask with as many elements as this object has blocks and * of which exactly the one component is true that corresponds to the given - * argument. See @ref GlossBlockMask "the glossary" for more information. + * argument. See + * @ref GlossBlockMask "the glossary" + * for more information. * * @note This function will only succeed if the scalar referenced by the * argument encompasses a complete block. In other words, if, for example, @@ -1245,7 +1268,8 @@ public: * Return a component mask with as many elements as this object has vector * components and of which exactly the dim components are true * that correspond to the given argument. See - * @ref GlossBlockMask "the glossary" for more information. + * @ref GlossBlockMask "the glossary" + * for more information. * * @note The same caveat applies as to the version of the function above: * The extractor object passed as argument must be so that it corresponds to @@ -1261,8 +1285,9 @@ public: /** * Return a component mask with as many elements as this object has vector * components and of which exactly the dim*(dim+1)/2 components - * are true that correspond to the given argument. See @ref GlossBlockMask - * "the glossary" for more information. + * are true that correspond to the given argument. See + * @ref GlossBlockMask "the glossary" + * for more information. * * @note The same caveat applies as to the version of the function above: * The extractor object passed as argument must be so that it corresponds to @@ -1278,8 +1303,11 @@ public: /** * Given a component mask (see - * @ref GlossComponentMask "this glossary entry"), produce a block mask - * (see @ref GlossBlockMask "this glossary entry") that represents the + * @ref GlossComponentMask "this glossary entry" + * ), produce a block mask + * (see + * @ref GlossBlockMask "this glossary entry" + * ) that represents the * blocks that correspond to the components selected in the input * argument. This is essentially a conversion operator from ComponentMask * to BlockMask. diff --git a/include/deal.II/fe/fe_abf.h b/include/deal.II/fe/fe_abf.h index 9be270709d..dd1b41dc08 100644 --- a/include/deal.II/fe/fe_abf.h +++ b/include/deal.II/fe/fe_abf.h @@ -60,7 +60,9 @@ template class MappingQ; * *

Interpolation

* - * The @ref GlossInterpolation "interpolation" operators associated with the + * The + * @ref GlossInterpolation "interpolation" + * operators associated with the * RT element are constructed such that interpolation and computing the * divergence are commuting operations. We require this from interpolating * arbitrary functions as well as the #restriction matrices. It can be @@ -69,7 +71,9 @@ template class MappingQ; * *

Node values on edges/faces

* - * On edges or faces, the @ref GlossNodes "node values" are the moments of the + * On edges or faces, the + * @ref GlossNodes "node values" + * are the moments of the * normal component of the interpolated function with respect to the traces of * the RT polynomials. Since the normal trace of the RT space of degree * k on an edge/face is the space Qk, the moments are diff --git a/include/deal.II/fe/fe_base.h b/include/deal.II/fe/fe_base.h index 2bd0a73768..b8dd096f43 100644 --- a/include/deal.II/fe/fe_base.h +++ b/include/deal.II/fe/fe_base.h @@ -55,7 +55,9 @@ namespace FiniteElementDomination * This enum is used in the FiniteElement::compare_for_face_domination() * function that is used in the context of hp finite element methods when * determining what to do at faces where two different finite elements meet - * (see the @ref hp_paper "hp paper" for a more detailed description of the + * (see the + * @ref hp_paper "hp paper" + * for a more detailed description of the * following). In that case, the degrees of freedom of one side need to be * constrained to those on the other side. The determination which side is * which is based on the outcome of a comparison for mutual domination: the @@ -67,7 +69,8 @@ namespace FiniteElementDomination * function. * * Note that there are situations where neither side dominates. The - * @ref hp_paper "hp paper" lists two case, with the simpler one being + * @ref hp_paper "hp paper" + * lists two case, with the simpler one being * that a $Q_2\times Q_1$ vector-valued element (i.e. a * FESystem(FE_Q(2),1,FE_Q(1),1)) meets a $Q_1\times Q_2$ * element: here, for each of the two vector-components, we can define a @@ -89,7 +92,8 @@ namespace FiniteElementDomination * which is an element that has no degrees of freedom in a subdomain. It * could also be used by discontinuous elements, for example. * - * More details on domination can be found in the @ref hp_paper "hp paper". + * More details on domination can be found in the + * @ref hp_paper "hp paper". */ enum Domination { @@ -373,14 +377,16 @@ public: unsigned int n_dofs_per_object () const; /** - * Number of components. See @ref GlossComponent "the glossary" for more - * information. + * Number of components. See + * @ref GlossComponent "the glossary" + * for more information. */ unsigned int n_components () const; /** - * Number of blocks. See @ref GlossBlock "the glossary" for more - * information. + * Number of blocks. See + * @ref GlossBlock "the glossary" + * for more information. */ unsigned int n_blocks () const; @@ -424,8 +430,9 @@ protected: /** * Set the primitivity of the element. This is usually done by the - * constructor of a derived class. See @ref GlossPrimitive "primitive" for - * details. + * constructor of a derived class. See + * @ref GlossPrimitive "primitive" + * for details. */ void set_primitivity(const bool value); diff --git a/include/deal.II/fe/fe_dgp.h b/include/deal.II/fe/fe_dgp.h index 8f6471da11..3739d19b16 100644 --- a/include/deal.II/fe/fe_dgp.h +++ b/include/deal.II/fe/fe_dgp.h @@ -184,7 +184,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_dgp_monomial.h b/include/deal.II/fe/fe_dgp_monomial.h index 56aab7b939..e2f8c6dddf 100644 --- a/include/deal.II/fe/fe_dgp_monomial.h +++ b/include/deal.II/fe/fe_dgp_monomial.h @@ -163,7 +163,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_dgp_nonparametric.h b/include/deal.II/fe/fe_dgp_nonparametric.h index 4a2dcf46c5..a1294a25a0 100644 --- a/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/include/deal.II/fe/fe_dgp_nonparametric.h @@ -233,7 +233,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_dgq.h b/include/deal.II/fe/fe_dgq.h index bf996354e3..31010002fb 100644 --- a/include/deal.II/fe/fe_dgq.h +++ b/include/deal.II/fe/fe_dgq.h @@ -252,7 +252,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_face.h b/include/deal.II/fe/fe_face.h index ecedda82bc..21d231b404 100644 --- a/include/deal.II/fe/fe_face.h +++ b/include/deal.II/fe/fe_face.h @@ -112,7 +112,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination @@ -211,7 +212,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination @@ -413,7 +415,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_nedelec.h b/include/deal.II/fe/fe_nedelec.h index 1a96a05eb3..bb7fce2c5a 100644 --- a/include/deal.II/fe/fe_nedelec.h +++ b/include/deal.II/fe/fe_nedelec.h @@ -119,7 +119,9 @@ template class MappingQ; * *

Interpolation

* - * The @ref GlossInterpolation "interpolation" operators associated with the + * The + * @ref GlossInterpolation "interpolation" + * operators associated with the * Nédélec element are constructed such that interpolation and * computing the curl are commuting operations on rectangular mesh cells. We * require this from interpolating arbitrary functions as well as the @@ -127,7 +129,9 @@ template class MappingQ; * *

Node values

* - * The @ref GlossNodes "node values" for an element of degree k on the + * The + * @ref GlossNodes "node values" + * for an element of degree k on the * reference cell are: *
    *
  1. On edges: the moments of the tangential component with respect to diff --git a/include/deal.II/fe/fe_nothing.h b/include/deal.II/fe/fe_nothing.h index 21624e675c..25719d02c8 100644 --- a/include/deal.II/fe/fe_nothing.h +++ b/include/deal.II/fe/fe_nothing.h @@ -220,7 +220,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". * * In the current case, this element is always assumed to dominate, unless * it is also of type FE_Nothing(). In that situation, either element can diff --git a/include/deal.II/fe/fe_q_base.h b/include/deal.II/fe/fe_q_base.h index 61165e8fad..e9b2c478a8 100644 --- a/include/deal.II/fe/fe_q_base.h +++ b/include/deal.II/fe/fe_q_base.h @@ -176,11 +176,15 @@ public: * @param face The number of the face this degree of freedom lives on. This * number must be between zero and GeometryInfo::faces_per_cell. * @param face_orientation One part of the description of the orientation of - * the face. See @ref GlossFaceOrientation . + * the face. See + * @ref GlossFaceOrientation. * @param face_flip One part of the description of the orientation of the - * face. See @ref GlossFaceOrientation . + * face. See + * @ref GlossFaceOrientation. * @param face_rotation One part of the description of the orientation of - * the face. See @ref GlossFaceOrientation . @return The index of this + * the face. See + * @ref GlossFaceOrientation. + * @return The index of this * degree of freedom within the set of degrees of freedom on the entire * cell. The returned value will be between zero and dofs_per_cell. */ @@ -254,7 +258,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_q_hierarchical.h b/include/deal.II/fe/fe_q_hierarchical.h index 96d15f1656..722a606054 100644 --- a/include/deal.II/fe/fe_q_hierarchical.h +++ b/include/deal.II/fe/fe_q_hierarchical.h @@ -588,7 +588,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_q_iso_q1.h b/include/deal.II/fe/fe_q_iso_q1.h index e01d09e3dd..991432491b 100644 --- a/include/deal.II/fe/fe_q_iso_q1.h +++ b/include/deal.II/fe/fe_q_iso_q1.h @@ -132,7 +132,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h index e008546518..d76c663f4c 100644 --- a/include/deal.II/fe/fe_raviart_thomas.h +++ b/include/deal.II/fe/fe_raviart_thomas.h @@ -66,7 +66,9 @@ template class MappingQ; * *

    Interpolation

    * - * The @ref GlossInterpolation "interpolation" operators associated with the + * The + * @ref GlossInterpolation "interpolation" + * operators associated with the * RT element are constructed such that interpolation and computing the * divergence are commuting operations. We require this from interpolating * arbitrary functions as well as the #restriction matrices. It can be @@ -75,7 +77,9 @@ template class MappingQ; * *

    Node values on edges/faces

    * - * On edges or faces, the @ref GlossNodes "node values" are the moments of the + * On edges or faces, the + * @ref GlossNodes "node values" + * are the moments of the * normal component of the interpolated function with respect to the traces of * the RT polynomials. Since the normal trace of the RT space of degree * k on an edge/face is the space Qk, the moments are diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index aa6b6b4261..3b9e4951aa 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -35,7 +35,9 @@ DEAL_II_NAMESPACE_OPEN * that are possibly of different type. The result is then a vector-valued * finite element. %Vector valued elements are discussed in a number of * tutorial programs, for example step-8, step-20, step-21, and in particular - * in the @ref vector_valued module. + * in the + * @ref vector_valued + * module. * *

    FESystem, components and blocks

    * @@ -56,7 +58,8 @@ DEAL_II_NAMESPACE_OPEN * partial differential equation, the finite element side looks a bit * different Since not only FESystem, but also vector-valued elements like * FE_RaviartThomas, have several components. The concept needed here is a - * @ref GlossBlock "block". Each block encompasses the set of degrees of + * @ref GlossBlock "block". + * Each block encompasses the set of degrees of * freedom associated with a single base element of an FESystem, where base * elements with multiplicities count multiple times. These blocks are usually * addressed using the information in DoFHandler::block_info(). The number of @@ -430,13 +433,17 @@ public: * @param face The number of the face this degree of freedom lives on. This * number must be between zero and GeometryInfo::faces_per_cell. * @param face_orientation One part of the description of the orientation of - * the face. See @ref GlossFaceOrientation . + * the face. See + * @ref GlossFaceOrientation. * @param face_flip One part of the description of the orientation of the - * face. See @ref GlossFaceOrientation . + * face. See + * @ref GlossFaceOrientation. * @param face_rotation One part of the description of the orientation of - * the face. See @ref GlossFaceOrientation . @return The index of this - * degree of freedom within the set of degrees of freedom on the entire - * cell. The returned value will be between zero and dofs_per_cell. + * the face. See + * @ref GlossFaceOrientation. + * @return The index of this degree of freedom within the set of degrees of + * freedom on the entire cell. The returned value will be between zero and + * dofs_per_cell. */ virtual unsigned int face_to_cell_index (const unsigned int face_dof_index, @@ -558,7 +565,8 @@ public: * neither dominates, or if either could dominate. * * For a definition of domination, see FiniteElementBase::Domination and in - * particular the @ref hp_paper "hp paper". + * particular the + * @ref hp_paper "hp paper". */ virtual FiniteElementDomination::Domination diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index 6968f55cce..06dec8c9d2 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -918,7 +918,9 @@ namespace FETools * * Note also that this table exists once for each space dimension. If you * have a program that works with finite elements in different space - * dimensions (for example, @ref step_4 "step-4" does something like this), + * dimensions (for example, + * @ref step_4 "step-4" + * does something like this), * then you should call this function for each space dimension for which you * want your finite element added to the map. */ @@ -966,7 +968,8 @@ namespace FETools DeclException0 (ExcInvalidFE); /** - * The finite element must be @ref GlossPrimitive "primitive". + * The finite element must be + * @ref GlossPrimitive "primitive". * * @ingroup Exceptions */ diff --git a/include/deal.II/fe/fe_update_flags.h b/include/deal.II/fe/fe_update_flags.h index f438a71a64..cdd55c2856 100644 --- a/include/deal.II/fe/fe_update_flags.h +++ b/include/deal.II/fe/fe_update_flags.h @@ -73,7 +73,8 @@ DEAL_II_NAMESPACE_OPEN * flags. * * The mechanism by which all this is accomplished is also discussed on the - * page on @ref UpdateFlagsEssay. + * page on + * @ref UpdateFlagsEssay. */ enum UpdateFlags { diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 1ff5ddc59b..bc3502a893 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -120,7 +120,9 @@ namespace internal * order tensor components consisting of (dim*dim + dim)/2 * elements * - * See the description of the @ref vector_valued module for examples how to + * See the description of the + * @ref vector_valued + * module for examples how to * use the features of this namespace. * * @ingroup feaccess vector_valued @@ -130,7 +132,8 @@ namespace FEValuesViews /** * A class representing a view to a single scalar component of a possibly * vector-valued finite element. Views are discussed in the - * @ref vector_valued module. + * @ref vector_valued + * module. * * You get an object of this type if you apply a FEValuesExtractors::Scalar * to an FEValues, FEFaceValues or FESubfaceValues object. @@ -341,7 +344,9 @@ namespace FEValuesViews /** * A class representing a view to a set of spacedim components * forming a vector part of a vector-valued finite element. Views are - * discussed in the @ref vector_valued module. + * discussed in the + * @ref vector_valued + * module. * * Note that in the current context, a vector is meant in the sense physics * uses it: it has spacedim components that behave in specific @@ -731,7 +736,9 @@ namespace FEValuesViews /** * A class representing a view to a set of (dim*dim + dim)/2 * components forming a symmetric second-order tensor from a vector-valued - * finite element. Views are discussed in the @ref vector_valued module. + * finite element. Views are discussed in the + * @ref vector_valued + * module. * * This class allows to query the value and divergence of (components of) * shape functions and solutions representing symmetric tensors. The @@ -935,7 +942,9 @@ namespace FEValuesViews /** * A class representing a view to a set of dim*dim components * forming a second-order tensor from a vector-valued finite element. Views - * are discussed in the @ref vector_valued module. + * are discussed in the + * @ref vector_valued + * module. * * This class allows to query the value and divergence of (components of) * shape functions and solutions representing tensors. The divergence of a @@ -2252,7 +2261,9 @@ public: * Create a view of the current FEValues object that represents a particular * scalar component of the possibly vector-valued finite element. The * concept of views is explained in the documentation of the namespace - * FEValuesViews and in particular in the @ref vector_valued module. + * FEValuesViews and in particular in the + * @ref vector_valued + * module. */ const FEValuesViews::Scalar & operator[] (const FEValuesExtractors::Scalar &scalar) const; @@ -2261,7 +2272,8 @@ public: * Create a view of the current FEValues object that represents a set of * dim scalar components (i.e. a vector) of the vector-valued * finite element. The concept of views is explained in the documentation of - * the namespace FEValuesViews and in particular in the @ref vector_valued + * the namespace FEValuesViews and in particular in the + * @ref vector_valued * module. */ const FEValuesViews::Vector & @@ -2272,7 +2284,9 @@ public: * (dim*dim + dim)/2 scalar components (i.e. a symmetric 2nd * order tensor) of the vector-valued finite element. The concept of views * is explained in the documentation of the namespace FEValuesViews and in - * particular in the @ref vector_valued module. + * particular in the + * @ref vector_valued + * module. */ const FEValuesViews::SymmetricTensor<2,dim,spacedim> & operator[] (const FEValuesExtractors::SymmetricTensor<2> &tensor) const; @@ -2283,7 +2297,8 @@ public: * (dim*dim) scalar components (i.e. a 2nd order tensor) of the * vector-valued finite element. The concept of views is explained in the * documentation of the namespace FEValuesViews and in particular in the - * @ref vector_valued module. + * @ref vector_valued + * module. */ const FEValuesViews::Tensor<2,dim,spacedim> & operator[] (const FEValuesExtractors::Tensor<2> &tensor) const; @@ -2677,7 +2692,8 @@ public: /** * Boundary form of the transformation of the cell at the ith - * quadrature point. See @ref GlossBoundaryForm . + * quadrature point. See + * @ref GlossBoundaryForm. * * @dealiiRequiresUpdateFlags{update_boundary_forms} */ diff --git a/include/deal.II/fe/fe_values_extractors.h b/include/deal.II/fe/fe_values_extractors.h index 813e8f315e..8a87a40512 100644 --- a/include/deal.II/fe/fe_values_extractors.h +++ b/include/deal.II/fe/fe_values_extractors.h @@ -32,7 +32,9 @@ DEAL_II_NAMESPACE_OPEN * dim elements, and second order symmetric tensors consisting of * (dim*dim + dim)/2 components * - * See the description of the @ref vector_valued module for examples how to + * See the description of the + * @ref vector_valued + * module for examples how to * use the features of this namespace. * * @ingroup feaccess vector_valued @@ -44,7 +46,9 @@ namespace FEValuesExtractors * result of applying an object of this type to an FEValues, FEFaceValues or * FESubfaceValues object is of type FEValuesViews::Scalar. The concept of * extractors is defined in the documentation of the namespace - * FEValuesExtractors and in the @ref vector_valued module. + * FEValuesExtractors and in the + * @ref vector_valued + * module. * * @ingroup feaccess vector_valued */ @@ -79,7 +83,9 @@ namespace FEValuesExtractors * object is of type FEValuesViews::Vector. * * The concept of extractors is defined in the documentation of the - * namespace FEValuesExtractors and in the @ref vector_valued module. + * namespace FEValuesExtractors and in the + * @ref vector_valued + * module. * * Note that in the current context, a vector is meant in the sense physics * uses it: it has spacedim components that behave in specific @@ -129,7 +135,8 @@ namespace FEValuesExtractors * type FEValuesViews::SymmetricTensor. * * The concept of extractors is defined in the documentation of the - * namespace FEValuesExtractors and in the @ref vector_valued module. + * namespace FEValuesExtractors and in the + * @ref vector_valued module. * * @ingroup feaccess vector_valued * @@ -170,7 +177,8 @@ namespace FEValuesExtractors * FEValuesViews::Tensor. * * The concept of extractors is defined in the documentation of the - * namespace FEValuesExtractors and in the @ref vector_valued module. + * namespace FEValuesExtractors and in the + * @ref vector_valued module. * * @ingroup feaccess vector_valued * diff --git a/include/deal.II/fe/mapping.h b/include/deal.II/fe/mapping.h index a6279429c2..53cb2f00ba 100644 --- a/include/deal.II/fe/mapping.h +++ b/include/deal.II/fe/mapping.h @@ -614,7 +614,8 @@ private: * fields not asked for by FEValues, but computed for efficiency reasons * will be notified here. * - * See @ref UpdateFlagsEssay. + * See + * @ref UpdateFlagsEssay. */ virtual UpdateFlags update_once (const UpdateFlags) const = 0; @@ -622,7 +623,8 @@ private: * The same as update_once(), but for the flags to be updated for each grid * cell. * - * See @ref UpdateFlagsEssay. + * See + * @ref UpdateFlagsEssay. */ virtual UpdateFlags update_each (const UpdateFlags) const = 0; @@ -692,7 +694,9 @@ private: /** * Performs the same as @p fill_fe_values on a face. Additionally, @p - * boundary_form (see @ref GlossBoundaryForm) and @p normal_vectors can be + * boundary_form (see + * @ref GlossBoundaryForm + * ) and @p normal_vectors can be * computed on surfaces. Since the boundary form already contains the * determinant of the Jacobian of the transformation, it is sometimes more * economic to use the boundary form instead of the product of the unit diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index e04361deba..0199828d57 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -38,7 +38,8 @@ template class SparseMatrix; * * Some of these functions receive a flag @p colorize. If this is set, parts * of the boundary receive different boundary indicators ( - * @ref GlossBoundaryIndicator), allowing them to be distinguished for the + * @ref GlossBoundaryIndicator + * ), allowing them to be distinguished for the * purpose of attaching geometry objects and evaluating different boundary * conditions. * @@ -815,7 +816,9 @@ namespace GridGenerator * * * @tparam Container A type that satisfies the requirements of a mesh - * container (see @ref GlossMeshAsAContainer). The map that is returned will + * container (see + * @ref GlossMeshAsAContainer + * ). 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 the * Container argument is DoFHandler of hp::DoFHandler, then the function diff --git a/include/deal.II/grid/grid_in.h b/include/deal.II/grid/grid_in.h index 9dfdb09768..9a9fd0083c 100644 --- a/include/deal.II/grid/grid_in.h +++ b/include/deal.II/grid/grid_in.h @@ -289,7 +289,8 @@ struct SubCellData; * cells it creates as part of the coarse mesh are distorted or not (where * distortion here means that the Jacobian of the mapping from the reference * cell to the real cell has a non-positive determinant, i.e. the cell is - * pinched or twisted; see the entry on @ref GlossDistorted "distorted cells" + * pinched or twisted; see the entry on + * @ref GlossDistorted "distorted cells" * in the glossary). If it finds any such cells, it throws an exception. This * exception is not caught in the grid reader functions of the current class, * and so will propagate through to the function that called it. There, you diff --git a/include/deal.II/grid/grid_out.h b/include/deal.II/grid/grid_out.h index cc53ae816b..4c5d363550 100644 --- a/include/deal.II/grid/grid_out.h +++ b/include/deal.II/grid/grid_out.h @@ -311,7 +311,9 @@ namespace GridOutFlags /** * Should lines with a set @p user_flag be drawn in a different color - * (red)? See @ref GlossUserFlags for information about user flags. + * (red)? See + * @ref GlossUserFlags + * for information about user flags. */ bool color_lines_on_user_flag; diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 8684e46778..5c63425279 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -332,7 +332,9 @@ namespace GridTools * located closest to a given point. * * @param container A variable of a type that satisfies the requirements of - * a mesh container (see @ref GlossMeshAsAContainer). + * a mesh container (see + * @ref GlossMeshAsAContainer + * ). * @param p The point for which we want to find the closest vertex. @return * The index of the closest vertex found. * @@ -352,7 +354,9 @@ 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 - * a mesh container (see @ref GlossMeshAsAContainer). + * a mesh container (see + * @ref GlossMeshAsAContainer + * ). * @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. @@ -389,7 +393,9 @@ namespace GridTools * additional computational cost. * * @param container A variable of a type that satisfies the requirements of - * a mesh container (see @ref GlossMeshAsAContainer). + * a mesh container (see + * @ref GlossMeshAsAContainer + * ). * @param p The point for which we want to find the surrounding cell. * @return An iterator into the mesh container that points to the * surrounding cell. diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index c97b472a07..812341f2f0 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -780,7 +780,8 @@ namespace internal * changed using a call of the kind * cell-@>face(1)-@>set_boundary_indicator(42);. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" * * *

    History of a triangulation

    @@ -836,12 +837,14 @@ namespace internal * field can be accessed as all other data using iterators. Normally, this * user flag is used if an algorithm walks over all cells and needs * information whether another cell, e.g. a neighbor, has already been - * processed. See @ref GlossUserFlags "the glossary for more information". + * processed. See + * @ref GlossUserFlags "the glossary for more information". * * There is another set of user data, which can be either an unsigned * int or a void *, for each line, quad, etc. You can access * these through the functions listed under User data in the accessor - * classes. Again, see @ref GlossUserData "the glossary for more information". + * classes. Again, see + * @ref GlossUserData "the glossary for more information". * * The value of these user indices or pointers is @p NULL by default. Note * that the pointers are not inherited to children upon refinement. Still, @@ -903,7 +906,8 @@ namespace internal * cell. 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". + * extensively in + * @ref GlossDistorted "distorted cells". * * *

    Getting notice when a triangulation changes

    @@ -1400,7 +1404,8 @@ public: /** * A typedef that is used to to identify - * @ref GlossActive "active cell iterators". The concept of iterators is + * @ref GlossActive "active cell iterators". + * The concept of iterators is * discussed at length in the * @ref Iterators "iterators documentation module". * @@ -1524,7 +1529,8 @@ public: * A structure that is used as an exception object by the * create_triangulation() function to indicate which cells among the coarse * mesh cells are inverted or severely distorted (see the entry on - * @ref GlossDistorted "distorted cells" in the glossary). + * @ref GlossDistorted "distorted cells" + * in the glossary). * * Objects of this kind are thrown by the create_triangulation() and * execute_coarsening_and_refinement() functions, and they can be caught in @@ -1575,7 +1581,9 @@ public: * @param check_for_distorted_cells Determines whether the triangulation * should check whether any of the cells that are created by * create_triangulation() or execute_coarsening_and_refinement() are - * distorted (see @ref GlossDistorted "distorted cells"). If set, these two + * distorted (see + * @ref GlossDistorted "distorted cells" + * ). If set, these two * functions may throw an exception if they encounter distorted cells. */ Triangulation (const MeshSmoothing smooth_grid = none, @@ -1652,7 +1660,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ void set_boundary (const types::manifold_id number, const Boundary &boundary_object); @@ -1666,7 +1675,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ void set_boundary (const types::manifold_id number); @@ -1691,7 +1701,8 @@ public: * * @ingroup manifold * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ void set_manifold (const types::manifold_id number, const Manifold &manifold_object); @@ -1705,7 +1716,8 @@ public: * * @ingroup manifold * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ void set_manifold (const types::manifold_id number); @@ -1715,7 +1727,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ const Boundary &get_boundary (const types::manifold_id number) const; @@ -1725,7 +1738,8 @@ public: * * @ingroup manifold * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ const Manifold &get_manifold (const types::manifold_id number) const; @@ -1737,7 +1751,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ std::vector get_boundary_indicators() const; @@ -1749,7 +1764,8 @@ public: * * @ingroup manifold * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ std::vector get_manifold_ids() const; @@ -1800,7 +1816,9 @@ public: * If the check_for_distorted_cells flag was specified upon * creation of this object, at the very end of its operation, the current * function walks over all cells and verifies that none of the cells is - * deformed (see the entry on @ref GlossDistorted "distorted cells" in the + * deformed (see the entry on + * @ref GlossDistorted "distorted cells" + * in the * glossary), where we call a cell deformed if the determinant of the * Jacobian of the mapping from reference cell to real cell is negative at * least at one of the vertices (this computation is done using the @@ -1843,7 +1861,7 @@ public: /** * Revert or flip the direction_flags of a dim &v) const; /** * Read the information stored by @p save_user_flags. See also - * @ref GlossUserFlags . + * @ref GlossUserFlags. */ void load_user_flags (std::istream &in); /** * Read the information stored by @p save_user_flags. See also - * @ref GlossUserFlags . + * @ref GlossUserFlags. */ void load_user_flags (const std::vector &v); /** - * Clear all user flags on lines. See also @ref GlossUserFlags . + * Clear all user flags on lines. See also + * @ref GlossUserFlags. */ void clear_user_flags_line (); /** - * Save the user flags on lines. See also @ref GlossUserFlags . + * Save the user flags on lines. See also + * @ref GlossUserFlags. */ void save_user_flags_line (std::ostream &out) const; /** * Same as above, but store the flags to a bitvector rather than to a file. - * The output vector is resized if necessary. See also @ref GlossUserFlags . + * The output vector is resized if necessary. See also + * @ref GlossUserFlags. */ void save_user_flags_line (std::vector &v) const; /** - * Load the user flags located on lines. See also @ref GlossUserFlags . + * Load the user flags located on lines. See also + * @ref GlossUserFlags. */ void load_user_flags_line (std::istream &in); /** - * Load the user flags located on lines. See also @ref GlossUserFlags . + * Load the user flags located on lines. See also + * @ref GlossUserFlags. */ void load_user_flags_line (const std::vector &v); /** - * Clear all user flags on quads. See also @ref GlossUserFlags . + * Clear all user flags on quads. See also + * @ref GlossUserFlags. */ void clear_user_flags_quad (); /** - * Save the user flags on quads. See also @ref GlossUserFlags . + * Save the user flags on quads. See also + * @ref GlossUserFlags. */ void save_user_flags_quad (std::ostream &out) const; /** * Same as above, but store the flags to a bitvector rather than to a file. - * The output vector is resized if necessary. See also @ref GlossUserFlags . + * The output vector is resized if necessary. See also + * @ref GlossUserFlags. */ void save_user_flags_quad (std::vector &v) const; /** - * Load the user flags located on quads. See also @ref GlossUserFlags . + * Load the user flags located on quads. See also + * @ref GlossUserFlags. */ void load_user_flags_quad (std::istream &in); /** - * Load the user flags located on quads. See also @ref GlossUserFlags . + * Load the user flags located on quads. See also + * @ref GlossUserFlags. */ void load_user_flags_quad (const std::vector &v); /** - * Clear all user flags on quads. See also @ref GlossUserFlags . + * Clear all user flags on quads. See also + * @ref GlossUserFlags. */ void clear_user_flags_hex (); /** - * Save the user flags on hexs. See also @ref GlossUserFlags . + * Save the user flags on hexs. See also + * @ref GlossUserFlags. */ void save_user_flags_hex (std::ostream &out) const; /** * Same as above, but store the flags to a bitvector rather than to a file. - * The output vector is resized if necessary. See also @ref GlossUserFlags . + * The output vector is resized if necessary. See also + * @ref GlossUserFlags. */ void save_user_flags_hex (std::vector &v) const; /** - * Load the user flags located on hexs. See also @ref GlossUserFlags . + * Load the user flags located on hexs. See also + * @ref GlossUserFlags. */ void load_user_flags_hex (std::istream &in); /** - * Load the user flags located on hexs. See also @ref GlossUserFlags . + * Load the user flags located on hexs. See also + * @ref GlossUserFlags. */ void load_user_flags_hex (const std::vector &v); /** * Clear all user pointers and indices and allow the use of both for next - * access. See also @ref GlossUserData . + * access. See also + * @ref GlossUserData. */ void clear_user_data (); /** * @deprecated User clear_user_data() instead. * - * Clear all user pointers. See also @ref GlossUserData . + * Clear all user pointers. See also + * @ref GlossUserData. */ void clear_user_pointers () DEAL_II_DEPRECATED; /** * Save all user indices. The output vector is resized if necessary. See - * also @ref GlossUserData . + * also + * @ref GlossUserData. */ void save_user_indices (std::vector &v) const; /** * Read the information stored by save_user_indices(). See also - * @ref GlossUserData . + * @ref GlossUserData. */ void load_user_indices (const std::vector &v); /** * Save all user pointers. The output vector is resized if necessary. See - * also @ref GlossUserData . + * also + * @ref GlossUserData. */ void save_user_pointers (std::vector &v) const; /** * Read the information stored by save_user_pointers(). See also - * @ref GlossUserData . + * @ref GlossUserData. */ void load_user_pointers (const std::vector &v); /** * Save the user indices on lines. The output vector is resized if - * necessary. See also @ref GlossUserData . + * necessary. See also + * @ref GlossUserData. */ void save_user_indices_line (std::vector &v) const; /** - * Load the user indices located on lines. See also @ref GlossUserData . + * Load the user indices located on lines. See also + * @ref GlossUserData. */ void load_user_indices_line (const std::vector &v); /** * Save the user indices on quads. The output vector is resized if - * necessary. See also @ref GlossUserData . + * necessary. See also + * @ref GlossUserData. */ void save_user_indices_quad (std::vector &v) const; /** - * Load the user indices located on quads. See also @ref GlossUserData . + * Load the user indices located on quads. See also + * @ref GlossUserData. */ void load_user_indices_quad (const std::vector &v); /** * Save the user indices on hexes. The output vector is resized if - * necessary. See also @ref GlossUserData . + * necessary. See also + * @ref GlossUserData. */ void save_user_indices_hex (std::vector &v) const; /** - * Load the user indices located on hexs. See also @ref GlossUserData . + * Load the user indices located on hexs. See also + * @ref GlossUserData. */ void load_user_indices_hex (const std::vector &v); /** * Save the user indices on lines. The output vector is resized if - * necessary. See also @ref GlossUserData . + * necessary. See also + * @ref GlossUserData. */ void save_user_pointers_line (std::vector &v) const; /** - * Load the user pointers located on lines. See also @ref GlossUserData . + * Load the user pointers located on lines. See also + * @ref GlossUserData. */ void load_user_pointers_line (const std::vector &v); /** * Save the user pointers on quads. The output vector is resized if - * necessary. See also @ref GlossUserData . + * necessary. See also + * @ref GlossUserData. */ void save_user_pointers_quad (std::vector &v) const; /** - * Load the user pointers located on quads. See also @ref GlossUserData . + * Load the user pointers located on quads. See also + * @ref GlossUserData. */ void load_user_pointers_quad (const std::vector &v); /** * Save the user pointers on hexes. The output vector is resized if - * necessary. See also @ref GlossUserData . + * necessary. See also + * @ref GlossUserData. */ void save_user_pointers_hex (std::vector &v) const; /** - * Load the user pointers located on hexs. See also @ref GlossUserData . + * Load the user pointers located on hexs. See also + * @ref GlossUserData. */ void load_user_pointers_hex (const std::vector &v); @@ -2368,7 +2419,8 @@ public: /** * Return an iterator range that contains all active cells that make up this * triangulation. Such a range is useful to initialize range-based for loops - * as supported by C++11, see also @ref CPP11 "C++11 standard". + * as supported by C++11, see also + * @ref CPP11 "C++11 standard". * * Range-based for loops are useful in that they require much less code than * traditional loops (see
    check_for_distorted_cells
    flag was specified upon creation * of this object, at */ diff --git a/include/deal.II/grid/tria_accessor.h b/include/deal.II/grid/tria_accessor.h index 7890ec676d..f83671dc22 100644 --- a/include/deal.II/grid/tria_accessor.h +++ b/include/deal.II/grid/tria_accessor.h @@ -130,7 +130,9 @@ namespace TriaAccessorExceptions */ DeclException0 (ExcCellNotUsed); /** - * The cell is not an @ref GlossActive "active" cell, but it already has + * The cell is not an + * @ref GlossActive "active" + * cell, but it already has * children. Some operations, like setting refinement flags or accessing * degrees of freedom are only possible on active cells. * @@ -233,7 +235,7 @@ namespace TriaAccessorExceptions * (structdim<dim). * * Some internals of this class are discussed in - * @ref IteratorAccessorInternals . + * @ref IteratorAccessorInternals. * * @ingroup grid * @ingroup Accessors @@ -648,7 +650,9 @@ public: * assignment, thereby moving the vertex of a cell within the triangulation. * Of course, doing so requires that you ensure that the new location of the * vertex remains useful -- for example, avoiding inverted or otherwise - * distorted (see also @ref GlossDistorted "this glossary entry"). + * distorted (see also + * @ref GlossDistorted "this glossary entry" + * ). * * @note When a cell is refined, its children inherit the position of the * vertex positions of those vertices they share with the mother cell (plus @@ -666,7 +670,9 @@ public: * @note The behavior described above is relevant if you have a * parallel::distributed::Triangulation object. There, refining a mesh * always involves a re-partitioning. In other words, vertices of locally - * owned cells (see @ref GlossLocallyOwnedCell "this glossary entry") that + * owned cells (see + * @ref GlossLocallyOwnedCell "this glossary entry" + * ) that * you may have moved to a different location on one processor may be moved * to a different processor upon mesh refinement (even if these particular * cells were not refined) which will re-create their position based on the @@ -868,7 +874,8 @@ public: * numbers::internal_face_boundary_id, then this object is in the interior * of the domain. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ types::boundary_id boundary_indicator () const; @@ -898,7 +905,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ void set_boundary_indicator (const types::boundary_id) const; @@ -929,7 +937,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ void set_all_boundary_indicators (const types::boundary_id) const; @@ -953,8 +962,8 @@ public: * Return a constant reference to the manifold object used for this object. * * As explained in - * @ref boundary "Boundary and manifold description for triangulations", - * the process involved in finding the appropriate manifold description + * @ref boundary "Boundary and manifold description for triangulations" + * , the process involved in finding the appropriate manifold description * involves querying both the manifold or boundary indicators. See there * for more information. */ @@ -977,7 +986,8 @@ public: * If the return value is the special value numbers::flat_manifold_id, then * this object is associated with a standard Cartesian Manifold Description. * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ types::manifold_id manifold_id () const; @@ -995,7 +1005,8 @@ public: * * @ingroup manifold * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ void set_manifold_id (const types::manifold_id) const; @@ -1009,7 +1020,8 @@ public: * * @ingroup manifold * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ void set_all_manifold_ids (const types::manifold_id) const; @@ -1025,35 +1037,44 @@ public: * @{ */ /** - * Read the user flag. See @ref GlossUserFlags for more information. + * Read the user flag. See + * @ref GlossUserFlags + * for more information. */ bool user_flag_set () const; /** - * Set the user flag. See @ref GlossUserFlags for more information. + * Set the user flag. See + * @ref GlossUserFlags + * for more information. */ void set_user_flag () const; /** - * Clear the user flag. See @ref GlossUserFlags for more information. + * Clear the user flag. See + * @ref GlossUserFlags + * for more information. */ void clear_user_flag () const; /** - * Set the user flag for this and all descendants. See @ref GlossUserFlags + * Set the user flag for this and all descendants. See + * @ref GlossUserFlags * for more information. */ void recursively_set_user_flag () const; /** - * Clear the user flag for this and all descendants. See @ref GlossUserFlags + * Clear the user flag for this and all descendants. See + * @ref GlossUserFlags * for more information. */ void recursively_clear_user_flag () const; /** * Reset the user data to zero, independent if pointer or index. See - * @ref GlossUserData for more information. + * @ref GlossUserData + * for more information. */ void clear_user_data () const; @@ -1064,13 +1085,16 @@ public: * you can only use one of them, unless you call * Triangulation::clear_user_data() in between. * - * See @ref GlossUserData for more information. + * See + * @ref GlossUserData + * for more information. */ void set_user_pointer (void *p) const; /** - * Reset the user pointer to a @p NULL pointer. See @ref GlossUserData for - * more information. + * Reset the user pointer to a @p NULL pointer. See + * @ref GlossUserData + * for more information. */ void clear_user_pointer () const; @@ -1084,7 +1108,9 @@ public: * Triangulation::clear_user_data() in between. A * *a=static_cast(cell->user_pointer());. * - * See @ref GlossUserData for more information. + * See + * @ref GlossUserData + * for more information. */ void *user_pointer () const; @@ -1105,14 +1131,17 @@ public: * you can only use one of them, unless you call * Triangulation::clear_user_data() in between. * - * See @ref GlossUserData for more information. + * See + * @ref GlossUserData + * for more information. */ void recursively_set_user_pointer (void *p) const; /** * Clear the user pointer of this object and all of its descendants. The * same holds as said for the recursively_set_user_pointer() function. See - * @ref GlossUserData for more information. + * @ref GlossUserData + * for more information. */ void recursively_clear_user_pointer () const; @@ -1121,13 +1150,16 @@ public: * * @note User pointers and user indices are mutually exclusive. Therefore, * you can only use one of them, unless you call - * Triangulation::clear_user_data() in between. See @ref GlossUserData for - * more information. + * Triangulation::clear_user_data() in between. See + * @ref GlossUserData + * for more information. */ void set_user_index (const unsigned int p) const; /** - * Reset the user index to 0. See @ref GlossUserData for more information. + * Reset the user index to 0. See + * @ref GlossUserData + * for more information. */ void clear_user_index () const; @@ -1138,7 +1170,9 @@ public: * you can only use one of them, unless you call * Triangulation::clear_user_data() in between. * - * See @ref GlossUserData for more information. + * See + * @ref GlossUserData + * for more information. */ unsigned int user_index () const; @@ -1155,7 +1189,9 @@ public: * you can only use one of them, unless you call * Triangulation::clear_user_data() in between. * - * See @ref GlossUserData for more information. + * See + * @ref GlossUserData + * for more information. */ void recursively_set_user_index (const unsigned int p) const; @@ -1163,7 +1199,9 @@ public: * Clear the user index of this object and all of its descendants. The same * holds as said for the recursively_set_user_index() function. * - * See @ref GlossUserData for more information. + * See + * @ref GlossUserData + * for more information. */ void recursively_clear_user_index () const; /** @@ -1658,14 +1696,16 @@ public: * numbers::internal_face_boundary_id, then this object is in the interior * of the domain. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ types::boundary_id boundary_indicator () const; /** * Return the manifold indicator of this object. * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ types::manifold_id manifold_id () const; @@ -1790,7 +1830,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ void set_boundary_indicator (const types::boundary_id); @@ -1812,7 +1853,8 @@ public: * * @ingroup boundary * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ void set_all_boundary_indicators (const types::boundary_id); @@ -1825,7 +1867,8 @@ public: * * @ingroup manifold * - * @see @ref GlossManifoldIndicator "Glossary entry on manifold indicators" + * @see + * @ref GlossManifoldIndicator "Glossary entry on manifold indicators" */ void @@ -2222,20 +2265,26 @@ public: /** * Return the material id of this cell. * - * For a typical use of this function, see the @ref step_28 "step-28" + * For a typical use of this function, see the + * @ref step_28 "step-28" * tutorial program. * - * See the @ref GlossMaterialId "glossary" for more information. + * See the + * @ref GlossMaterialId "glossary" + * for more information. */ types::material_id material_id () const; /** * Set the material id of this cell. * - * For a typical use of this function, see the @ref step_28 "step-28" + * For a typical use of this function, see the + * @ref step_28 "step-28" * tutorial program. * - * See the @ref GlossMaterialId "glossary" for more information. + * See the + * @ref GlossMaterialId "glossary" + * for more information. */ void set_material_id (const types::material_id new_material_id) const; @@ -2243,7 +2292,9 @@ public: * Set the material id of this cell and all its children (and grand- * children, and so on) to the given value. * - * See the @ref GlossMaterialId "glossary" for more information. + * See the + * @ref GlossMaterialId "glossary" + * for more information. */ void recursively_set_material_id (const types::material_id new_material_id) const; /** @@ -2260,7 +2311,9 @@ public: /** * Return the subdomain id of this cell. * - * See the @ref GlossSubdomainId "glossary" for more information. + * See the + * @ref GlossSubdomainId "glossary" + * for more information. * * @note The subdomain of a cell is a property only defined for active * cells, i.e., cells that are not further refined. Consequently, you can @@ -2274,7 +2327,9 @@ public: /** * Set the subdomain id of this cell. * - * See the @ref GlossSubdomainId "glossary" for more information. This + * See the + * @ref GlossSubdomainId "glossary" + * for more information. This * function should not be called if you use a * parallel::distributed::Triangulation object. * @@ -2309,7 +2364,9 @@ public: * and grand children of this cell that are actually active, skipping * intermediate child cells. * - * See the @ref GlossSubdomainId "glossary" for more information. This + * See the + * @ref GlossSubdomainId "glossary" + * for more information. This * function should not be called if you use a * parallel::distributed::Triangulation object since there the subdomain id * is implicitly defined by which processor you're on. @@ -2329,7 +2386,8 @@ public: /** * Return the orientation of this cell. * - * For the meaning of this flag, see @ref GlossDirectionFlag . + * For the meaning of this flag, see + * @ref GlossDirectionFlag. */ bool direction_flag () const; @@ -2365,7 +2423,9 @@ public: * Test whether the cell has children (this is the criterion for activity of * a cell). * - * See the @ref GlossActive "glossary" for more information. + * See the + * @ref GlossActive "glossary" + * for more information. */ bool active () const; @@ -2375,7 +2435,11 @@ public: * object of type dealii::Triangulation, but may yield false if the * triangulation is of type parallel::distributed::Triangulation. * - * See the @ref GlossGhostCell "glossary" and the @ref distributed module + * See the + * @ref GlossGhostCell "glossary" + * and the + * @ref distributed + * module * for more information. * * @post The returned value is equal to !is_ghost() && @@ -2403,7 +2467,11 @@ public: * parallel::distributed::Triangulation. In all other cases, the returned * value is always false. * - * See the @ref GlossGhostCell "glossary" and the @ref distributed module + * See the + * @ref GlossGhostCell "glossary" + * and the + * @ref distributed + * module * for more information. * * @post The returned value is equal to !is_locally_owned() && @@ -2428,7 +2496,10 @@ public: * parallel::distributed::Triangulation. In all other cases, the returned * value is always false. * - * See the @ref GlossArtificialCell "glossary" and the @ref distributed + * See the + * @ref GlossArtificialCell "glossary" + * and the + * @ref distributed * module for more information. * * @post The returned value is equal to !is_ghost() && @@ -2536,7 +2607,8 @@ private: /** * Set the orientation of this cell. * - * For the meaning of this flag, see @ref GlossDirectionFlag . + * For the meaning of this flag, see + * @ref GlossDirectionFlag. */ void set_direction_flag (const bool new_direction_flag) const; /** diff --git a/include/deal.II/grid/tria_iterator_selector.h b/include/deal.II/grid/tria_iterator_selector.h index 355d62a105..df566bc945 100644 --- a/include/deal.II/grid/tria_iterator_selector.h +++ b/include/deal.II/grid/tria_iterator_selector.h @@ -39,7 +39,8 @@ namespace internal /** * This class implements some types which differ between the dimensions. - * These are the declararions for the 1D case only. See the @ref Iterators + * These are the declararions for the 1D case only. See the + * @ref Iterators * module for more information. * * A @p line_iterator is typdef'd to an iterator operating on the @p lines @@ -88,7 +89,8 @@ namespace internal /** * This class implements some types which differ between the dimensions. - * These are the declararions for the 2D case only. See the @ref Iterators + * These are the declararions for the 2D case only. See the + * @ref Iterators * module for more information. * * A @p line_iterator is typdef'd to an iterator operating on the @p lines @@ -142,7 +144,8 @@ namespace internal /** * This class implements some types which differ between the dimensions. - * These are the declararions for the 3D case only. See the @ref Iterators + * These are the declararions for the 3D case only. See the + * @ref Iterators * module for more information. * * For the declarations of the data types, more or less the same holds as diff --git a/include/deal.II/hp/dof_handler.h b/include/deal.II/hp/dof_handler.h index b5b4ab5e56..36d48a77f1 100644 --- a/include/deal.II/hp/dof_handler.h +++ b/include/deal.II/hp/dof_handler.h @@ -88,7 +88,8 @@ namespace hp * * The whole process of working with objects of this type is explained in * step-27. Many of the algorithms this class implements are described in - * the @ref hp_paper "hp paper". + * the + * @ref hp_paper "hp paper". * * *

    Active FE indices and their behavior under mesh refinement

    @@ -133,7 +134,8 @@ namespace hp /** * A typedef that is used to to identify - * @ref GlossActive "active cell iterators". The concept of iterators + * @ref GlossActive "active cell iterators". + * The concept of iterators * is discussed at length in the * @ref Iterators "iterators documentation module". * @@ -162,7 +164,8 @@ namespace hp * * The current typedef identifies cells in a DoFHandler object. Some of * these cells may in fact be active (see - * @ref GlossActive "active cell iterators") in which case they can in + * @ref GlossActive "active cell iterators" + * ) in which case they can in * fact be asked for the degrees of freedom that live on them. On the * other hand, if the cell is not active, any such query will result in * an error. Note that this is what distinguishes this typedef from the @@ -316,7 +319,8 @@ namespace hp * As for ::DoFHandler::max_couplings_between_dofs(), the result of this * function is often not very accurate for 3d and/or high polynomial * degrees. The consequences are discussed in the documentation of the - * module on @ref Sparsity. + * module on + * @ref Sparsity. */ unsigned int max_couplings_between_dofs () const; @@ -329,7 +333,8 @@ namespace hp * * @note The same applies to this function as to max_couplings_per_dofs() * as regards the performance of this function. Think about one of the - * dynamic sparsity pattern classes instead (see @ref Sparsity). + * dynamic sparsity pattern classes instead (see + * @ref Sparsity). */ unsigned int max_couplings_between_boundary_dofs () const; @@ -394,7 +399,8 @@ namespace hp /** * Return an iterator range that contains all active cells that make up * this DoFHandler. Such a range is useful to initialize range-based for - * loops as supported by C++11, see also @ref CPP11 "C++11 standard". + * loops as supported by C++11, see also + * @ref CPP11 "C++11 standard". * * Range-based for loops are useful in that they require much less code * than traditional loops (see
    dim FE_Q objects and one copy of an * FE_RaviartThomas element. Both have dim vector @@ -242,9 +245,12 @@ namespace hp component_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const; /** - * Given a block mask (see @ref GlossBlockMask "this glossary entry"), + * Given a block mask (see + * @ref GlossBlockMask "this glossary entry" + * ), * produce a component mask (see - * @ref GlossComponentMask "this glossary entry") that represents the + * @ref GlossComponentMask "this glossary entry" + * ) that represents the * components that correspond to the blocks selected in the input * argument. This is essentially a conversion operator from BlockMask * to ComponentMask. @@ -265,7 +271,9 @@ namespace hp /** * Return a block mask with as many elements as this object has blocks and * of which exactly the one component is true that corresponds to the - * given argument. See @ref GlossBlockMask "the glossary" for more + * given argument. See + * @ref GlossBlockMask "the glossary" + * for more * information. * * @note This function will only succeed if the scalar referenced by the @@ -293,8 +301,9 @@ namespace hp /** * Return a component mask with as many elements as this object has vector * components and of which exactly the dim components are - * true that correspond to the given argument. See @ref GlossBlockMask - * "the glossary" for more information. + * true that correspond to the given argument. See + * @ref GlossBlockMask "the glossary" + * for more information. * * @note This function is the equivalent of * FiniteElement::component_mask() with the same arguments. It verifies @@ -317,7 +326,8 @@ namespace hp * Return a component mask with as many elements as this object has vector * components and of which exactly the dim*(dim+1)/2 * components are true that correspond to the given argument. See - * @ref GlossBlockMask "the glossary" for more information. + * @ref GlossBlockMask "the glossary" + * for more information. * * @note The same caveat applies as to the version of the function above: * The extractor object passed as argument must be so that it corresponds @@ -339,8 +349,11 @@ namespace hp /** * Given a component mask (see - * @ref GlossComponentMask "this glossary entry"), produce a block mask - * (see @ref GlossBlockMask "this glossary entry") that represents the + * @ref GlossComponentMask "this glossary entry" + * ), produce a block mask + * (see + * @ref GlossBlockMask "this glossary entry" + * ) that represents the * blocks that correspond to the components selected in the input * argument. This is essentially a conversion operator from * ComponentMask to BlockMask. diff --git a/include/deal.II/hp/mapping_collection.h b/include/deal.II/hp/mapping_collection.h index f81dcd2a25..a11de61486 100644 --- a/include/deal.II/hp/mapping_collection.h +++ b/include/deal.II/hp/mapping_collection.h @@ -32,7 +32,9 @@ namespace hp * This class implements a collection of mapping objects in the same way as * the hp::FECollection implements a collection of finite element classes. * - * It implements the concepts stated in the @ref hpcollection module + * It implements the concepts stated in the + * @ref hpcollection + * module * described in the doxygen documentation. * * Although it is recommended to supply an appropriate mapping for each diff --git a/include/deal.II/hp/q_collection.h b/include/deal.II/hp/q_collection.h index 270060b9b8..5af55ae450 100644 --- a/include/deal.II/hp/q_collection.h +++ b/include/deal.II/hp/q_collection.h @@ -34,7 +34,9 @@ namespace hp * as the hp::FECollection implements a collection of finite element * classes. * - * It implements the concepts stated in the @ref hpcollection module + * It implements the concepts stated in the + * @ref hpcollection + * module * described in the doxygen documentation. * * @ingroup hp hpcollection diff --git a/include/deal.II/lac/block_indices.h b/include/deal.II/lac/block_indices.h index 890d723935..f181b5f515 100644 --- a/include/deal.II/lac/block_indices.h +++ b/include/deal.II/lac/block_indices.h @@ -46,7 +46,9 @@ DEAL_II_NAMESPACE_OPEN * blocks, where you have to translate global row and column indices to local * ones. * - * @ingroup data @see @ref GlossBlockLA "Block (linear algebra)" + * @ingroup data + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, Guido Kanschat, 2000, 2007, 2011 */ class BlockIndices : public Subscriptor @@ -225,7 +227,8 @@ template class BlockSparseMatrixEZ; * do things differently depending on whether a template type denotes a * regular or a block matrix type. * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, 2009 */ template diff --git a/include/deal.II/lac/block_matrix.h b/include/deal.II/lac/block_matrix.h index 18491b8c29..139e97fbe6 100644 --- a/include/deal.II/lac/block_matrix.h +++ b/include/deal.II/lac/block_matrix.h @@ -38,7 +38,8 @@ DEAL_II_NAMESPACE_OPEN * One special application is a one by one block matrix, allowing to apply the * @p vmult of the original matrix (or preconditioner) to a block vector. * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Guido Kanschat, 2000 */ template diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index 44f9196142..88cad408db 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -329,9 +329,12 @@ namespace BlockMatrixIterators * * @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). * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, 2000, 2004 */ template @@ -619,8 +622,9 @@ public: * Call the compress() function on all the subblocks of the matrix. * * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (::dealii::VectorOperation::values operation); diff --git a/include/deal.II/lac/block_sparse_matrix.h b/include/deal.II/lac/block_sparse_matrix.h index 29fdddbc9d..c16afe1793 100644 --- a/include/deal.II/lac/block_sparse_matrix.h +++ b/include/deal.II/lac/block_sparse_matrix.h @@ -42,7 +42,8 @@ DEAL_II_NAMESPACE_OPEN * the calls to the individual blocks to the functions implemented in the base * class. See there also for a description of when this class is useful. * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, 2000, 2004 */ template diff --git a/include/deal.II/lac/block_sparse_matrix_ez.h b/include/deal.II/lac/block_sparse_matrix_ez.h index afb566bad7..449ec77d70 100644 --- a/include/deal.II/lac/block_sparse_matrix_ez.h +++ b/include/deal.II/lac/block_sparse_matrix_ez.h @@ -44,7 +44,8 @@ template class BlockVector; * functions for the multiplication with BlockVector and access to the * individual blocks. * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Guido Kanschat, 2002, 2003 */ template diff --git a/include/deal.II/lac/block_sparsity_pattern.h b/include/deal.II/lac/block_sparsity_pattern.h index 1953611503..902ebbbcb1 100644 --- a/include/deal.II/lac/block_sparsity_pattern.h +++ b/include/deal.II/lac/block_sparsity_pattern.h @@ -77,7 +77,8 @@ namespace TrilinosWrappers * @todo Handle optimization of diagonal elements of the underlying * SparsityPattern correctly. * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, 2000, 2001 */ template @@ -294,7 +295,8 @@ public: * Print the sparsity of the matrix in a format that gnuplot * understands and which can be used to plot the sparsity pattern in a * graphical way. This is the same functionality implemented for usual - * sparsity patterns, see @ref SparsityPattern. + * sparsity patterns, see + * @ref SparsityPattern. */ void print_gnuplot (std::ostream &out) const; @@ -381,7 +383,8 @@ private: * few additional member functions, but the main interface stems from the base * class, see there for more information. * - * This class is an example of the "static" type of @ref Sparsity. + * This class is an example of the "static" type of + * @ref Sparsity. * * @author Wolfgang Bangerth, 2000, 2001 */ @@ -478,10 +481,12 @@ public: * information on the interface of this class refer to the base class. The * individual blocks are based on the CompressedSparsityPattern class. * - * This class is an example of the "dynamic" type of @ref Sparsity. + * This class is an example of the "dynamic" type of + * @ref Sparsity. * * Note: There are several, exchangeable variations of this class, see - * @ref Sparsity, section 'Dynamic block sparsity patterns' for more + * @ref Sparsity + * , section 'Dynamic block sparsity patterns' for more * information. * * Note: This class used to be called CompressedBlockSparsityPattern. @@ -596,10 +601,12 @@ typedef BlockCompressedSparsityPattern CompressedBlockSparsityPattern DEAL_II_DE * CompressedSetSparsityPattern instead of the CompressedSparsityPattern. See * the documentation of the BlockCompressedSparsityPattern for examples. * - * This class is an example of the "dynamic" type of @ref Sparsity. + * This class is an example of the "dynamic" type of + * @ref Sparsity. * - * Note: There are several, exchangeable variations of this class, see - * @ref Sparsity, section 'Dynamic block sparsity patterns' for more + * @note There are several, exchangeable variations of this class, see + * @ref Sparsity + * , section 'Dynamic block sparsity patterns' for more * information. * * @author Wolfgang Bangerth, 2007 @@ -675,10 +682,12 @@ public: * CompressedSimpleSparsityPattern instead of the CompressedSparsityPattern. * See the documentation of the BlockCompressedSparsityPattern for examples. * - * This class is an example of the "dynamic" type of @ref Sparsity. + * This class is an example of the "dynamic" type of + * @ref Sparsity. * - * Note: There are several, exchangeable variations of this class, see - * @ref Sparsity, section 'Dynamic block sparsity patterns' for more + * @note There are several, exchangeable variations of this class, see + * @ref Sparsity + * , section 'Dynamic block sparsity patterns' for more * information. * * This class is used in step-22 and step-31. @@ -767,7 +776,9 @@ public: * TrilinosWrappers::SparsityPattern instead of the dealii::SparsityPattern. * See the documentation of the BlockSparsityPattern for examples. * - * This class is has properties of the "dynamic" type of @ref Sparsity (in the + * This class is has properties of the "dynamic" type of + * @ref Sparsity + * (in the * sense that it can extend the memory if too little elements were allocated), * but otherwise is more like the basic deal.II SparsityPattern (in the sense * that the method compress() needs to be called before the pattern can be diff --git a/include/deal.II/lac/block_vector.h b/include/deal.II/lac/block_vector.h index e22702c30b..68aae88496 100644 --- a/include/deal.II/lac/block_vector.h +++ b/include/deal.II/lac/block_vector.h @@ -51,9 +51,12 @@ namespace TrilinosWrappers * * @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). * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, Guido Kanschat, 1999, 2000, 2001, 2002, 2004 */ template @@ -166,7 +169,9 @@ public: * This functionality only needs to be called if using MPI based vectors and * exists in other objects for compatibility. * - * See @ref GlossCompress "Compressing distributed objects" for more + * See + * @ref GlossCompress "Compressing distributed objects" + * for more * information. */ void compress (::dealii::VectorOperation::values operation diff --git a/include/deal.II/lac/block_vector_base.h b/include/deal.II/lac/block_vector_base.h index 943100c2fc..9b15eab2bc 100644 --- a/include/deal.II/lac/block_vector_base.h +++ b/include/deal.II/lac/block_vector_base.h @@ -550,7 +550,8 @@ namespace internal * calling collect_sizes(), results may be unpredictable. The debug version * does not check consistency here for performance reasons! * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, Guido Kanschat, 1999, 2000, 2001, 2002, 2004 */ template @@ -622,8 +623,9 @@ public: * This functionality only needs to be called if using MPI based vectors and * exists in other objects for compatibility. * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (::dealii::VectorOperation::values operation); diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index 2cdba2cacb..acb85947c2 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -399,7 +399,9 @@ namespace ChunkSparseMatrixIterators * * @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 Wolfgang Bangerth, 2008 */ @@ -830,7 +832,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockChunkSparseMatrix as well. @@ -848,7 +851,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockChunkSparseMatrix as well. @@ -865,7 +869,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockChunkSparseMatrix as well. @@ -883,7 +888,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockChunkSparseMatrix as well. diff --git a/include/deal.II/lac/chunk_sparsity_pattern.h b/include/deal.II/lac/chunk_sparsity_pattern.h index 913d30395a..7edecdbc5a 100644 --- a/include/deal.II/lac/chunk_sparsity_pattern.h +++ b/include/deal.II/lac/chunk_sparsity_pattern.h @@ -215,7 +215,9 @@ namespace ChunkSparsityPatternIterators /** * Structure representing the sparsity pattern of a sparse matrix. This class - * is an example of the "static" type of @ref Sparsity. It uses the compressed + * is an example of the "static" type of + * @ref Sparsity. + * It uses the compressed * row storage (CSR) format to store data. * * The use of this class is demonstrated in step-51. diff --git a/include/deal.II/lac/compressed_set_sparsity_pattern.h b/include/deal.II/lac/compressed_set_sparsity_pattern.h index 78760b48e1..986a267ad9 100644 --- a/include/deal.II/lac/compressed_set_sparsity_pattern.h +++ b/include/deal.II/lac/compressed_set_sparsity_pattern.h @@ -48,11 +48,15 @@ template class SparseMatrix; * * Another viewpoint is that this class does not need up front allocation of a * certain amount of memory, but grows as necessary. An extensive description - * of sparsity patterns can be found in the documentation of the @ref Sparsity + * of sparsity patterns can be found in the documentation of the + * @ref Sparsity * module. * - * This class is an example of the "dynamic" type of @ref Sparsity. It is - * discussed in the step-27 and @ref step_22 "step-22" tutorial programs. + * This class is an example of the "dynamic" type of + * @ref Sparsity. + * It is discussed in the step-27 and + * @ref step_22 "step-22" + * tutorial programs. * *

    Interface

    * @@ -81,7 +85,8 @@ template class SparseMatrix; *

    Notes

    * * There are several, exchangeable variations of this class, see - * @ref Sparsity, section '"Dynamic" or "compressed" sparsity patterns' for more + * @ref Sparsity + * , section '"Dynamic" or "compressed" sparsity patterns' for more * information. * * This class is a variation of the CompressedSparsityPattern class. Instead @@ -90,7 +95,9 @@ template class SparseMatrix; * solution might not be the fastest in all situations, but seems to work much * better than the CompressedSparsityPattern in the context of hp-adaptivity * (see for example step-27), or generally when there are many nonzero entries - * in each row of a matrix (see @ref step_22 "step-22"). On the other hand, a + * in each row of a matrix (see + * @ref step_22 "step-22" + * ). On the other hand, a * benchmark where nonzero entries were randomly inserted into the sparsity * pattern revealed that this class is slower by a factor 4-6 in this * situation. Hence, currently the suggestion is to carefully analyze which of diff --git a/include/deal.II/lac/compressed_simple_sparsity_pattern.h b/include/deal.II/lac/compressed_simple_sparsity_pattern.h index 9daa10aa37..5c5c8bc98d 100644 --- a/include/deal.II/lac/compressed_simple_sparsity_pattern.h +++ b/include/deal.II/lac/compressed_simple_sparsity_pattern.h @@ -51,10 +51,12 @@ template class SparseMatrix; * * Another viewpoint is that this class does not need up front allocation of a * certain amount of memory, but grows as necessary. An extensive description - * of sparsity patterns can be found in the documentation of the @ref Sparsity + * of sparsity patterns can be found in the documentation of the + * @ref Sparsity * module. * - * This class is an example of the "dynamic" type of @ref Sparsity. + * This class is an example of the "dynamic" type of + * @ref Sparsity. * *

    Interface

    * @@ -81,7 +83,8 @@ template class SparseMatrix; *

    Notes

    * * There are several, exchangeable variations of this class, see - * @ref Sparsity, section '"Dynamic" or "compressed" sparsity patterns' for + * @ref Sparsity + * , section '"Dynamic" or "compressed" sparsity patterns' for * more information. * * @author Timo Heister, 2008 diff --git a/include/deal.II/lac/compressed_sparsity_pattern.h b/include/deal.II/lac/compressed_sparsity_pattern.h index 410a911897..5565304aa8 100644 --- a/include/deal.II/lac/compressed_sparsity_pattern.h +++ b/include/deal.II/lac/compressed_sparsity_pattern.h @@ -53,10 +53,12 @@ template class SparseMatrix; * * Another viewpoint is that this class does not need up front allocation of a * certain amount of memory, but grows as necessary. An extensive description - * of sparsity patterns can be found in the documentation of the @ref Sparsity + * of sparsity patterns can be found in the documentation of the + * @ref Sparsity * module. * - * This class is an example of the "dynamic" type of @ref Sparsity. + * This class is an example of the "dynamic" type of + * @ref Sparsity. * *

    Interface

    * @@ -84,7 +86,8 @@ template class SparseMatrix; *

    Notes

    * * There are several, exchangeable variations of this class, see - * @ref Sparsity, section '"Dynamic" or "compressed" sparsity patterns' for + * @ref Sparsity + * , section '"Dynamic" or "compressed" sparsity patterns' for * more information. * * @author Wolfgang Bangerth, 2001 diff --git a/include/deal.II/lac/constraint_matrix.h b/include/deal.II/lac/constraint_matrix.h index 93984dde06..aeeaf9febd 100644 --- a/include/deal.II/lac/constraint_matrix.h +++ b/include/deal.II/lac/constraint_matrix.h @@ -70,7 +70,9 @@ namespace internals /** * This class implements dealing with linear (possibly inhomogeneous) * constraints on degrees of freedom. The concept and origin of such - * constraints is extensively described in the @ref constraints module. The + * constraints is extensively described in the + * @ref constraints + * module. The * class is meant to deal with a limited number of constraints relative to the * total number of degrees of freedom, for example a few per cent up to maybe * 30 per cent; and with a linear combination of M other degrees of @@ -79,8 +81,11 @@ namespace internals * not meant to describe full rank linear systems. * * The algorithms used in the implementation of this class are described in - * some detail in the @ref hp_paper "hp paper". There is also a significant - * amount of documentation on how to use this class in the @ref constraints + * some detail in the + * @ref hp_paper "hp paper". + * There is also a significant + * amount of documentation on how to use this class in the + * @ref constraints * module. * * @@ -126,7 +131,8 @@ namespace internals * and sorts the entries. * * @note Many of the algorithms this class implements are discussed in the - * @ref hp_paper . The algorithms are also related to those shown in M. S. + * @ref hp_paper. + * The algorithms are also related to those shown in M. S. * Shephard: Linear multipoint constraints applied via transformation as part * of a direct stiffness assembly process. Int. J. Numer. Meth. Engrg., vol. * 20 (1984), pp. 2107-2112., with the difference that the algorithms @@ -557,9 +563,11 @@ public: * or millions of unknowns are involved and for problems with many nonzero * elements per row (for example for vector-valued problems or hp finite * elements). In this case, it is advisable to use the - * CompressedSetSparsityPattern class instead, see for example @ref step_27 - * "step-27", or to use the CompressedSimpleSparsityPattern class, see for - * example @ref step_31 "step-31". + * CompressedSetSparsityPattern class instead, see for example + * @ref step_27 "step-27" + * , or to use the CompressedSimpleSparsityPattern class, see for + * example + * @ref step_31 "step-31". */ void condense (CompressedSparsityPattern &sparsity) const; @@ -586,7 +594,9 @@ public: * nonzero elements per row (for example for vector-valued problems or hp * finite elements). In this case, it is advisable to use the * BlockCompressedSetSparsityPattern class instead, see for example - * @ref step_27 "step-27" and @ref step_31 "step-31". + * @ref step_27 "step-27" + * and + * @ref step_31 "step-31". */ void condense (BlockCompressedSparsityPattern &sparsity) const; @@ -939,7 +949,8 @@ public: * according to the constraints specified by the calling ConstraintMatrix. * This function can correctly handle inhomogeneous constraints as well. For * the parameter use_inhomogeneities_for_rhs see the documentation in - * @ref constraints module. + * @ref constraints + * module. * * @note This function in itself is thread-safe, i.e., it works properly * also when several threads call it simultaneously. However, the function @@ -964,7 +975,9 @@ public: * freedom, except that here we don't write into a matrix but only allocate * sparsity pattern entries. * - * As explained in the @ref hp_paper "hp paper" and in step-27, first + * As explained in the + * @ref hp_paper "hp paper" + * and in step-27, first * allocating a sparsity pattern and later coming back and allocating * additional entries for those matrix entries that will be written to due * to the elimination of constrained degrees of freedom (using diff --git a/include/deal.II/lac/householder.h b/include/deal.II/lac/householder.h index d9cdcf3134..a2786d8c0b 100644 --- a/include/deal.II/lac/householder.h +++ b/include/deal.II/lac/householder.h @@ -46,7 +46,9 @@ template class Vector; * * @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 Guido Kanschat, 2005 */ diff --git a/include/deal.II/lac/matrix_lib.h b/include/deal.II/lac/matrix_lib.h index 69880bdb1c..c8546e3d18 100644 --- a/include/deal.II/lac/matrix_lib.h +++ b/include/deal.II/lac/matrix_lib.h @@ -403,7 +403,9 @@ private: * * @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 Guido Kanschat, 2005 */ diff --git a/include/deal.II/lac/parallel_block_vector.h b/include/deal.II/lac/parallel_block_vector.h index 7ae7034251..2bb2f7a48d 100644 --- a/include/deal.II/lac/parallel_block_vector.h +++ b/include/deal.II/lac/parallel_block_vector.h @@ -51,9 +51,12 @@ namespace parallel * * @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). + * (see the section on + * @ref Instantiations + * in the manual). * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Katharina Kormann, Martin Kronbichler, 2011 */ template @@ -256,8 +259,9 @@ namespace parallel /** * This function copies the data that has accumulated in the data buffer * for ghost indices to the owning processor. For the meaning of the - * argument @p operation, see the entry on @ref GlossCompress - * "Compressing distributed vectors and matrices" in the glossary. + * argument @p operation, see the entry on + * @ref GlossCompress "Compressing distributed vectors and matrices" + * in the glossary. * * There are two variants for this function. If called with argument @p * VectorOperation::add adds all the data accumulated in ghost elements diff --git a/include/deal.II/lac/parallel_vector.h b/include/deal.II/lac/parallel_vector.h index 56a1792582..fd861dc5c3 100644 --- a/include/deal.II/lac/parallel_vector.h +++ b/include/deal.II/lac/parallel_vector.h @@ -71,9 +71,11 @@ namespace parallel * exception that storage is distributed with MPI. * * The vector is designed for the following scheme of parallel - * partitioning: - The indices held by individual processes (locally owned + * partitioning: + * - The indices held by individual processes (locally owned * part) in the MPI parallelization form a contiguous range - * [my_first_index,my_last_index). - Ghost indices residing + * [my_first_index,my_last_index). + * - Ghost indices residing * on arbitrary positions of other processors are allowed. It is in * general more efficient if ghost indices are clustered, since they are * stored as a set of intervals. The communication pattern of the ghost @@ -83,14 +85,16 @@ namespace parallel * communication of indices. In particular, it stores the communication * pattern, rather than having to compute it again for every * communication. (For more information on ghost vectors, see also the - * @ref GlossGhostedVector "glossary entry on vectors with ghost elements".) + * @ref GlossGhostedVector "glossary entry on vectors with ghost elements" + * .) * - Besides the usual global access operator () it is also * possible to access vector entries in the local index space with the * function @p local_element(). Locally owned indices are placed first, * [0, local_size()), and then all ghost indices follow after them * contiguously, [local_size(), local_size()+n_ghost_entries()). * - * Functions related to parallel functionality: - The function + * Functions related to parallel functionality: + * - The function * compress() goes through the data associated with ghost * indices and communicates it to the owner process, which can then add it * to the correct position. This can be used e.g. after having run an @@ -98,20 +102,26 @@ namespace parallel * @p insert mode of @p compress() does not set the elements included in * ghost entries but simply discards them, assuming that the owning * processor has set them to the desired value already. (See also the - * @ref GlossCompress "glossary entry on compress".) - The + * @ref GlossCompress "glossary entry on compress" + * .) + * - The * update_ghost_values() function imports the data from the * owning processor to the ghost indices in order to provide read access - * to the data associated with ghosts. - It is possible to split the above + * to the data associated with ghosts. + * - It is possible to split the above * functions into two phases, where the first initiates the communication * and the second one finishes it. These functions can be used to overlap - * communication with computations in other parts of the code. - Of + * communication with computations in other parts of the code. + * - Of * course, reduction operations (like norms) make use of collective all- * to-all MPI communications. * * This vector can take two different states with respect to ghost - * elements: - After creation and whenever zero_out_ghosts() is called (or + * elements: + * - After creation and whenever zero_out_ghosts() is called (or * operator = (0.)), the vector does only allow writing into - * ghost elements but not reading from ghost elements. - After a call to + * ghost elements but not reading from ghost elements. + * - After a call to * update_ghost_values(), the vector does not allow writing into ghost * elements but only reading from them. This is in order to avoid * undesired ghost data artifacts when calling compress() after modifying @@ -195,7 +205,8 @@ namespace parallel * Vector argument to create additional vectors with the same * parallel layout. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ Vector (const IndexSet &local_range, const IndexSet &ghost_indices, @@ -253,7 +264,8 @@ namespace parallel * Vector argument to create additional vectors with the same * parallel layout. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void reinit (const IndexSet &local_range, const IndexSet &ghost_indices, @@ -347,8 +359,9 @@ namespace parallel /** * This function copies the data that has accumulated in the data buffer * for ghost indices to the owning processor. For the meaning of the - * argument @p operation, see the entry on @ref GlossCompress - * "Compressing distributed vectors and matrices" in the glossary. + * argument @p operation, see the entry on + * @ref GlossCompress "Compressing distributed vectors and matrices" + * in the glossary. * * There are two variants for this function. If called with argument @p * VectorOperation::add adds all the data accumulated in ghost elements @@ -390,7 +403,8 @@ namespace parallel * counting the ghost data more than once. To allow writing to ghost * elements again, call zero_out_ghosts(). * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void update_ghost_values () const; @@ -477,7 +491,8 @@ namespace parallel * still possible (to those entries specified as ghosts during * initialization), not that there are no ghost elements at all. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ bool has_ghost_elements() const; diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h index 0b46f89458..53a5b18dfc 100644 --- a/include/deal.II/lac/petsc_matrix_base.h +++ b/include/deal.II/lac/petsc_matrix_base.h @@ -523,8 +523,9 @@ namespace PETScWrappers * operations where before only assembly functions were allowed. This * function must therefore be called once you have assembled the matrix. * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. more information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (::dealii::VectorOperation::values operation); diff --git a/include/deal.II/lac/petsc_parallel_block_vector.h b/include/deal.II/lac/petsc_parallel_block_vector.h index 68be3bb698..36c848e6f6 100644 --- a/include/deal.II/lac/petsc_parallel_block_vector.h +++ b/include/deal.II/lac/petsc_parallel_block_vector.h @@ -54,7 +54,9 @@ namespace PETScWrappers * specify the sizes of the individual blocks, but also the number of * elements of each of these blocks to be stored on the local process. * - * @ingroup Vectors @see @ref GlossBlockLA "Block (linear algebra)" + * @ingroup Vectors + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Wolfgang Bangerth, 2004 */ class BlockVector : public BlockVectorBase diff --git a/include/deal.II/lac/petsc_precondition.h b/include/deal.II/lac/petsc_precondition.h index 0def3db8b1..d528e8d998 100644 --- a/include/deal.II/lac/petsc_precondition.h +++ b/include/deal.II/lac/petsc_precondition.h @@ -114,7 +114,9 @@ namespace PETScWrappers * A class that implements the interface to use the PETSc Jacobi * preconditioner. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers @@ -173,7 +175,9 @@ namespace PETScWrappers * the matrix for preconditioning. This can be changed, as is explained in * the relevant section of the PETSc manual, but is not implemented here. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers @@ -224,7 +228,9 @@ namespace PETScWrappers * A class that implements the interface to use the PETSc SOR * preconditioner. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers @@ -285,7 +291,9 @@ namespace PETScWrappers * A class that implements the interface to use the PETSc SSOR * preconditioner. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers @@ -346,7 +354,9 @@ namespace PETScWrappers * A class that implements the interface to use the PETSc Eisenstat * preconditioner. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers @@ -407,7 +417,9 @@ namespace PETScWrappers * A class that implements the interface to use the PETSc Incomplete * Cholesky preconditioner. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers @@ -468,7 +480,9 @@ namespace PETScWrappers * A class that implements the interface to use the PETSc ILU * preconditioner. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers @@ -530,7 +544,9 @@ namespace PETScWrappers * The LU decomposition is only implemented for single processor machines. * It should provide a convenient interface to another direct solver. * - * See the comment in the base class @ref PreconditionerBase for when this + * See the comment in the base class + * @ref PreconditionerBase + * for when this * preconditioner may or may not work. * * @ingroup PETScWrappers diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h index bee40b44e8..a6f3392a24 100644 --- a/include/deal.II/lac/petsc_vector_base.h +++ b/include/deal.II/lac/petsc_vector_base.h @@ -266,8 +266,9 @@ namespace PETScWrappers * necessary after writing into a vector element-by-element and before * anything else can be done on it. * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (::dealii::VectorOperation::values operation); @@ -355,7 +356,8 @@ namespace PETScWrappers /** * Return if the vector contains ghost elements. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ bool has_ghost_elements() const; diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index 0f2c85345e..4496c7ab2e 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -75,7 +75,8 @@ class PreconditionBlockJacobi; * for example, number==double, inverse_type=float might be a viable * choice. * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Ralf Hartmann, Guido Kanschat * @date 1999, 2000, 2010 */ @@ -369,7 +370,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 */ @@ -635,7 +638,9 @@ private: * * @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, 2001, 2002, 2003 */ @@ -790,7 +795,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 */ diff --git a/include/deal.II/lac/schur_matrix.h b/include/deal.II/lac/schur_matrix.h index b6596d743e..6bef61a714 100644 --- a/include/deal.II/lac/schur_matrix.h +++ b/include/deal.II/lac/schur_matrix.h @@ -89,7 +89,8 @@ DEAL_II_NAMESPACE_OPEN * schur.postprocess (u, p); * @endcode * - * @see @ref GlossBlockLA "Block (linear algebra)" + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Guido Kanschat, 2000, 2001, 2002 */ template diff --git a/include/deal.II/lac/slepc_solver.h b/include/deal.II/lac/slepc_solver.h index fc589ebf75..7855ac189a 100644 --- a/include/deal.II/lac/slepc_solver.h +++ b/include/deal.II/lac/slepc_solver.h @@ -89,9 +89,11 @@ DEAL_II_NAMESPACE_OPEN * @endcode * as an example on how to do this. * - * For further information and explanations on handling the @ref SLEPcWrappers - * "SLEPcWrappers", see also the @ref PETScWrappers "PETScWrappers", on which - * they depend. + * For further information and explanations on handling the + * @ref SLEPcWrappers "SLEPcWrappers" + * , see also the + * @ref PETScWrappers "PETScWrappers" + * , on which they depend. * * @ingroup SLEPcWrappers * diff --git a/include/deal.II/lac/sparse_direct.h b/include/deal.II/lac/sparse_direct.h index f066f7b062..d485b273fe 100644 --- a/include/deal.II/lac/sparse_direct.h +++ b/include/deal.II/lac/sparse_direct.h @@ -41,7 +41,10 @@ DEAL_II_NAMESPACE_OPEN * systems, Ax=b, using the Unsymmetric-pattern MultiFrontal method and direct * sparse LU factorization. Matrices may have symmetric or unsymmetrix * sparsity patterns, and may have unsymmetric entries. The use of this class - * is explained in the @ref step_22 "step-22" and @ref step_29 "step-29" + * is explained in the + * @ref step_22 "step-22" + * and + * @ref step_29 "step-29" * tutorial programs. * * This matrix class implements the usual interface of preconditioners, that diff --git a/include/deal.II/lac/sparse_ilu.h b/include/deal.II/lac/sparse_ilu.h index b5bb0b366a..fb72d42d69 100644 --- a/include/deal.II/lac/sparse_ilu.h +++ b/include/deal.II/lac/sparse_ilu.h @@ -44,12 +44,15 @@ DEAL_II_NAMESPACE_OPEN *

    Usage and state management

    * * Refer to SparseLUDecomposition documentation for suggested usage and state - * management. This class is used in the @ref step_22 "step-22" tutorial - * program. + * management. This class is used in the + * @ref step_22 "step-22" + * tutorial program. * * @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 Wolfgang Bangerth, 2008, 2009; unified interface: Ralf Hartmann */ diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index 2407dfe73b..83ca387baa 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -480,7 +480,9 @@ namespace SparseMatrixIterators * * @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). * * @ingroup Matrix1 * @author Essentially everyone who has ever worked on deal.II @@ -1067,7 +1069,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockSparseMatrix as well. @@ -1087,7 +1090,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockSparseMatrix as well. @@ -1104,7 +1108,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockSparseMatrix as well. @@ -1124,7 +1129,8 @@ public: * * Note that while this function can operate on all vectors that offer * iterator classes, it is only really effective for objects of type - * @ref Vector. For all classes for which iterating over elements, or random + * @ref Vector. + * For all classes for which iterating over elements, or random * member access is expensive, this function is not efficient. In * particular, if you want to multiply with BlockVector objects, you should * consider using a BlockSparseMatrix as well. diff --git a/include/deal.II/lac/sparse_vanka.h b/include/deal.II/lac/sparse_vanka.h index a4fc542160..2fb44cf8ae 100644 --- a/include/deal.II/lac/sparse_vanka.h +++ b/include/deal.II/lac/sparse_vanka.h @@ -122,7 +122,9 @@ template class SparseBlockVanka; * * @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 Guido Kanschat, Wolfgang Bangerth; 1999, 2000 */ diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index 55ed83f778..ee4295367c 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -322,7 +322,9 @@ namespace SparsityPatternIterators /** * Structure representing the sparsity pattern of a sparse matrix. This class - * is an example of the "static" type of @ref Sparsity. It uses the compressed + * is an example of the "static" type of + * @ref Sparsity. + * It uses the compressed * row storage (CSR) format to store data. * * The elements of a SparsityPattern, corresponding to the places where @@ -343,7 +345,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/lac/swappable_vector.h b/include/deal.II/lac/swappable_vector.h index 6b21f8203b..bd2734ac1d 100644 --- a/include/deal.II/lac/swappable_vector.h +++ b/include/deal.II/lac/swappable_vector.h @@ -46,7 +46,9 @@ DEAL_II_NAMESPACE_OPEN * * @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 Wolfgang Bangerth, 1999, 2000 */ diff --git a/include/deal.II/lac/trilinos_block_vector.h b/include/deal.II/lac/trilinos_block_vector.h index 1422247e69..e8e4a4eb4d 100644 --- a/include/deal.II/lac/trilinos_block_vector.h +++ b/include/deal.II/lac/trilinos_block_vector.h @@ -60,7 +60,9 @@ namespace TrilinosWrappers * processor, since the Trilinos matrices are inherently parallel. * * @ingroup Vectors - * @ingroup TrilinosWrappers @see @ref GlossBlockLA "Block (linear algebra)" + * @ingroup TrilinosWrappers + * @see + * @ref GlossBlockLA "Block (linear algebra)" * @author Martin Kronbichler, 2008 */ class BlockVector : public BlockVectorBase @@ -158,8 +160,9 @@ namespace TrilinosWrappers * * @deprecated * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED; diff --git a/include/deal.II/lac/trilinos_parallel_block_vector.h b/include/deal.II/lac/trilinos_parallel_block_vector.h index 21941e9067..1bb4e6cb42 100644 --- a/include/deal.II/lac/trilinos_parallel_block_vector.h +++ b/include/deal.II/lac/trilinos_parallel_block_vector.h @@ -62,7 +62,8 @@ namespace TrilinosWrappers * elements of each of these blocks to be stored on the local process. * * @ingroup Vectors - * @ingroup TrilinosWrappers @see + * @ingroup TrilinosWrappers + * @see * @ref GlossBlockLA "Block (linear algebra)" * @author Martin Kronbichler, Wolfgang Bangerth, 2008, 2009 */ @@ -268,8 +269,9 @@ namespace TrilinosWrappers * * @deprecated * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED; @@ -291,7 +293,8 @@ namespace TrilinosWrappers /** * Returns if this Vector contains ghost elements. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ bool has_ghost_elements() const; diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index e124590219..52e3518408 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -1082,8 +1082,9 @@ namespace TrilinosWrappers * vector products. This is a collective operation, i.e., it needs to be * run on all processors when used in %parallel. * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (::dealii::VectorOperation::values operation); diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index 93e8ace3cf..b904a01f9b 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -200,7 +200,8 @@ namespace TrilinosWrappers * above. * * What we call a 'ghosted' vector (see - * @ref GlossGhostedVector "vectors with ghost elements") is simply a + * @ref GlossGhostedVector "vectors with ghost elements" + * ) is simply a * view of the parallel vector where the element distributions overlap. * The 'ghosted' Trilinos vector in itself has no idea of which entries * are ghosted and which are locally owned. In fact, a ghosted vector @@ -390,7 +391,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ explicit Vector (const Epetra_Map ¶llel_partitioning); @@ -405,7 +407,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ Vector (const Epetra_Map ¶llel_partitioning, const VectorBase &v); @@ -419,7 +422,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ template void reinit (const Epetra_Map ¶llel_partitioner, @@ -434,7 +438,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void reinit (const Epetra_Map ¶llel_partitioning, const bool fast = false); @@ -448,7 +453,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ template Vector (const Epetra_Map ¶llel_partitioning, @@ -469,7 +475,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ explicit Vector (const IndexSet ¶llel_partitioning, const MPI_Comm &communicator = MPI_COMM_WORLD); @@ -482,7 +489,8 @@ namespace TrilinosWrappers * have ghost elements. See the general documentation of this class for * more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ Vector (const IndexSet &local, const IndexSet &ghost, @@ -499,7 +507,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ Vector (const IndexSet ¶llel_partitioning, const VectorBase &v, @@ -514,7 +523,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ template Vector (const IndexSet ¶llel_partitioning, @@ -533,7 +543,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void reinit (const IndexSet ¶llel_partitioning, const MPI_Comm &communicator = MPI_COMM_WORLD, @@ -561,7 +572,8 @@ namespace TrilinosWrappers * or may not have ghost elements. See the general documentation of this * class for more information. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ void reinit (const IndexSet &locally_owned_entries, const IndexSet &ghost_entries, diff --git a/include/deal.II/lac/trilinos_vector_base.h b/include/deal.II/lac/trilinos_vector_base.h index bc71a47354..9235eec0de 100644 --- a/include/deal.II/lac/trilinos_vector_base.h +++ b/include/deal.II/lac/trilinos_vector_base.h @@ -276,8 +276,9 @@ namespace TrilinosWrappers * argument is ignored if the vector has been added or written to since * the last time compress() was called. * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ void compress (::dealii::VectorOperation::values operation); @@ -416,7 +417,8 @@ namespace TrilinosWrappers * Return if the vector contains ghost elements. This answer is true if * there are ghost elements on at least one process. * - * @see @ref GlossGhostedVector "vectors with ghost elements" + * @see + * @ref GlossGhostedVector "vectors with ghost elements" */ bool has_ghost_elements() const; diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index 12451ed13a..176a752464 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -75,8 +75,9 @@ template class VectorView; * It is used in the various compress() functions. They also exist in serial * codes for compatibility and are empty there. * - * See @ref GlossCompress "Compressing distributed objects" for more - * information. + * See + * @ref GlossCompress "Compressing distributed objects" + * for more information. */ struct VectorOperation { @@ -99,7 +100,8 @@ struct VectorOperation * @, @, @@>, * @@>, @@>; others * can be generated in application programs (see the section on - * @ref Instantiations in the manual). + * @ref Instantiations + * in the manual). * * @author Guido Kanschat, Franz-Theo Suttmeier, Wolfgang Bangerth */ diff --git a/include/deal.II/meshworker/assembler.h b/include/deal.II/meshworker/assembler.h index 90f3818c6a..7c3b413d0e 100644 --- a/include/deal.II/meshworker/assembler.h +++ b/include/deal.II/meshworker/assembler.h @@ -94,7 +94,9 @@ namespace MeshWorker * * 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). Thus, the size of this local block is the number of + * ( + * @ref GlossBlock + * ). Thus, the size of this local block is the number of * degrees of freedom of the corresponding base element of the FESystem. * * @todo Comprehensive model currently not implemented. diff --git a/include/deal.II/multigrid/mg_base.h b/include/deal.II/multigrid/mg_base.h index 838cf27386..b5bc701ee6 100644 --- a/include/deal.II/multigrid/mg_base.h +++ b/include/deal.II/multigrid/mg_base.h @@ -126,8 +126,11 @@ public: * operate on all components of the solution. * * @note For the following, it is important to realize the difference between - * a solution @ref GlossComponent "component" and a solution @ref GlossBlock - * "block". The distinction only applies if vector valued elements are used, + * a solution + * @ref GlossComponent "component" + * and a solution + * @ref GlossBlock "block". + * The distinction only applies if vector valued elements are used, * but is quite important then. This is reflected in the fact that it is not * possible right now to use transfer classes based on MGTransferComponentBase * for genuine vector valued elements, but descendants of MGTransferBlockBase diff --git a/include/deal.II/multigrid/mg_dof_iterator_selector.h b/include/deal.II/multigrid/mg_dof_iterator_selector.h index 56e4b05f0e..cf39a9c26d 100644 --- a/include/deal.II/multigrid/mg_dof_iterator_selector.h +++ b/include/deal.II/multigrid/mg_dof_iterator_selector.h @@ -40,7 +40,8 @@ namespace internal /** - * Iterators for MGDofHandler in one dimension. See the @ref Iterators + * Iterators for MGDofHandler in one dimension. See the + * @ref Iterators * module for more information. */ template @@ -74,7 +75,8 @@ namespace internal /** - * Iterators for MGDofHandler in two dimensions. See the @ref Iterators + * Iterators for MGDofHandler in two dimensions. See the + * @ref Iterators * module for more information. */ template @@ -108,7 +110,8 @@ namespace internal /** - * Iterators for MGDofHandler in three dimensions. See the @ref Iterators + * Iterators for MGDofHandler in three dimensions. See the + * @ref Iterators * module for more information. */ template diff --git a/include/deal.II/multigrid/mg_tools.h b/include/deal.II/multigrid/mg_tools.h index 097af48ce2..0023c22b77 100644 --- a/include/deal.II/multigrid/mg_tools.h +++ b/include/deal.II/multigrid/mg_tools.h @@ -89,7 +89,11 @@ namespace MGTools /** * Make a sparsity pattern including fluxes of discontinuous Galerkin - * methods. @ref make_sparsity_pattern @ref DoFTools + * methods. + * @see + * @ref make_sparsity_pattern + * and + * @ref DoFTools */ template void diff --git a/include/deal.II/numerics/data_out_rotation.h b/include/deal.II/numerics/data_out_rotation.h index c32261a021..42811fe2a4 100644 --- a/include/deal.II/numerics/data_out_rotation.h +++ b/include/deal.II/numerics/data_out_rotation.h @@ -154,7 +154,9 @@ public: /** * Return the first cell which we want output for. The default - * implementation returns the first @ref GlossActive "active cell", but you + * implementation returns the first + * @ref GlossActive "active cell" + * , but you * might want to return other cells in a derived class. */ virtual cell_iterator first_cell (); diff --git a/include/deal.II/numerics/error_estimator.h b/include/deal.II/numerics/error_estimator.h index 2cf43e70b5..1a3f4e9597 100644 --- a/include/deal.II/numerics/error_estimator.h +++ b/include/deal.II/numerics/error_estimator.h @@ -236,7 +236,9 @@ public: * You might give a list of components you want to evaluate, in case the * finite element used by the DoFHandler object is vector-valued. You then * have to set those entries to true in the bit-vector @p component_mask - * (see @ref GlossComponentMask) for which the respective component is to be + * (see + * @ref GlossComponentMask + * ) for which the respective component is to be * used in the error estimator. The default is to use all components, which * is done by either providing a bit-vector with all-set entries, or an * empty bit-vector. diff --git a/include/deal.II/numerics/fe_field_function.h b/include/deal.II/numerics/fe_field_function.h index 0c1b9dd6bc..ff5ad91d94 100644 --- a/include/deal.II/numerics/fe_field_function.h +++ b/include/deal.II/numerics/fe_field_function.h @@ -110,7 +110,11 @@ namespace Functions * and evaluating the solution at a particular point, not every processor * will own the cell at which the solution is evaluated. Rather, it may be * that the cell in which this point is found is in fact a ghost or - * artificial cell (see @ref GlossArtificialCell and @ref GlossGhostCell). + * artificial cell (see + * @ref GlossArtificialCell + * and + * @ref GlossGhostCell + * ). * If the cell is artificial, we have no access to the solution there and * functions that evaluate the solution at such a point will trigger an * exception of type FEFieldFunction::ExcPointNotAvailableHere. The same @@ -190,7 +194,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void vector_value (const Point &p, @@ -208,7 +214,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual double value (const Point< dim > &p, @@ -224,7 +232,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void value_list (const std::vector > &points, @@ -242,7 +252,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void vector_value_list (const std::vector > &points, @@ -258,7 +270,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void @@ -275,7 +289,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual Tensor<1,dim> gradient(const Point< dim > &p, @@ -289,7 +305,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void @@ -305,7 +323,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void @@ -320,7 +340,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual double @@ -334,7 +356,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void @@ -347,7 +371,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void @@ -361,7 +387,9 @@ namespace Functions * @note When using this function on a * parallel::distributed::Triangulation you may get an exception when * trying to evaluate the solution at a point that does not lie in a - * locally owned cell (see @ref GlossLocallyOwnedCell). See the section in + * locally owned cell (see + * @ref GlossLocallyOwnedCell + * ). See the section in * the general documentation of this class for more information. */ virtual void diff --git a/include/deal.II/numerics/point_value_history.h b/include/deal.II/numerics/point_value_history.h index d393a64ac9..6fa4e445d0 100644 --- a/include/deal.II/numerics/point_value_history.h +++ b/include/deal.II/numerics/point_value_history.h @@ -102,13 +102,16 @@ namespace internal *
      *
    1. Firstly, the @p evaluate_field version that does not take a @p * DataPostprocessor object selects the nearest support point (see - * @ref GlossSupport "this entry in the glossary") to a given point to extract + * @ref GlossSupport "this entry in the glossary" + * ) to a given point to extract * data from. This makes the code that needs to be run at each time step * very * short, since looping over the mesh to extract the needed dof_index can be * done just once at the start. However, this method is not suitable for * FiniteElement objects that do not assign dofs to actual mesh locations - * (i.e. FEs without @ref GlossSupport "support points") or if adaptive mesh + * (i.e. FEs without + * @ref GlossSupport "support points" + * ) or if adaptive mesh * refinement is used. The reason for the latter restriction is that the * location of the closest support point to a given point may change upon mesh * refinement. The class will throw an exception if any change to the @@ -151,8 +154,11 @@ namespace internal *
    * * When recording a new mnemonic name, the user must supply a component_mask - * (see @ref GlossComponentMask "this glossary entry") to indicate the - * @ref GlossComponent "(vector) components" to be extracted from the given + * (see + * @ref GlossComponentMask "this glossary entry" + * ) to indicate the + * @ref GlossComponent "(vector) components" + * to be extracted from the given * input. If the user simply wants to extract all the components, the mask * need not be explicitly supplied to the @p add_field_name method and the * default value of the parameter is sufficient. If the @p evaluate_field diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h index 87181b23fe..c0c8f52c84 100644 --- a/include/deal.II/numerics/vector_tools.h +++ b/include/deal.II/numerics/vector_tools.h @@ -311,7 +311,9 @@ class ConstraintMatrix; * @note Instantiations for this template are provided for some vector types, * in particular Vector<float>, Vector<double>, * BlockVector<float>, BlockVector<double>; others can be - * generated in application code (see the section on @ref Instantiations in + * generated in application code (see the section on + * @ref Instantiations + * in * the manual). * * @ingroup numerics @@ -443,7 +445,9 @@ namespace VectorTools * first interpolate() function in the series. It interpolations a set of * functions onto the finite element space given by the DoFHandler argument * where the determination which function to use is made based on the - * material id (see @ref GlossMaterialId) of each cell. + * material id (see + * @ref GlossMaterialId + * ) of each cell. * * @param mapping - The mapping to use to determine the location of * support points at which the functions are to be evaluated. @@ -661,7 +665,9 @@ namespace VectorTools * it is assumed that the number of entries equals the number of components * in the boundary functions and the finite element, and those components in * the given boundary function will be used for which the respective flag - * was set in the component mask. See also @ref GlossComponentMask. As an + * was set in the component mask. See also + * @ref GlossComponentMask. + * As an * example, assume that you are solving the Stokes equations in 2d, with * variables $(u,v,p)$ and that you only want to interpolate boundary values * for the pressure, then the component mask should correspond to @@ -713,7 +719,8 @@ namespace VectorTools * previous function, in particular about the use of the component mask and * the requires size of the function object. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -730,7 +737,8 @@ namespace VectorTools * previous function, in particular about the use of the component mask and * the requires size of the function object. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -774,7 +782,8 @@ namespace VectorTools * are not set in the second operation on degrees of freedom that are * already constrained. This makes sure that the discretization remains * conforming as is needed. See the discussion on conflicting constraints in - * the module on @ref constraints . + * the module on + * @ref constraints. * * The parameter @p boundary_component corresponds to the number @p * boundary_indicator of the face. @@ -786,7 +795,9 @@ namespace VectorTools * it is assumed that the number of entries equals the number of components * in the boundary functions and the finite element, and those components in * the given boundary function will be used for which the respective flag - * was set in the component mask. See also @ref GlossComponentMask. As an + * was set in the component mask. See also + * @ref GlossComponentMask. + * As an * example, assume that you are solving the Stokes equations in 2d, with * variables $(u,v,p)$ and that you only want to interpolate boundary values * for the pressure, then the component mask should correspond to @@ -830,7 +841,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -849,7 +861,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void @@ -899,8 +912,9 @@ namespace VectorTools * numbering of degrees of freedom. * @param boundary_functions A map from boundary indicators to pointers to * functions that describe the desired values on those parts of the boundary - * marked with this boundary indicator (see @ref GlossBoundaryIndicator - * "Boundary indicator"). The projection happens on only those parts of the + * marked with this boundary indicator (see + * @ref GlossBoundaryIndicator "Boundary indicator" + * ). The projection happens on only those parts of the * boundary whose indicators are represented in this map. * @param q The face quadrature used in the integration necessary to compute * the mass matrix and right hand side of the projection. @@ -980,7 +994,8 @@ namespace VectorTools * are not set in the second operation on degrees of freedom that are * already constrained. This makes sure that the discretization remains * conforming as is needed. See the discussion on conflicting constraints in - * the module on @ref constraints . + * the module on + * @ref constraints. * * If @p component_mapping is empty, it is assumed that the number of * components of @p boundary_function matches that of the finite element @@ -1033,7 +1048,8 @@ namespace VectorTools * the Dirichlet conditions should be set first, and then completed by * hanging node constraints, in order to make sure that the discretization * remains consistent. See the discussion on conflicting constraints in the - * module on @ref constraints . + * module on + * @ref constraints. * * This function is explicitly written to use with the FE_Nedelec elements. * Thus it throws an exception, if it is called with other finite elements. @@ -1070,7 +1086,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void project_boundary_values_curl_conforming (const DoFHandler &dof_handler, @@ -1085,7 +1102,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void project_boundary_values_curl_conforming (const hp::DoFHandler &dof_handler, @@ -1115,7 +1133,8 @@ namespace VectorTools * the Dirichlet conditions should be set first, and then completed by * hanging node constraints, in order to make sure that the discretization * remains consistent. See the discussion on conflicting constraints in the - * module on @ref constraints . + * module on + * @ref constraints. * * The argument @p first_vector_component denotes the first vector component * in the finite element that corresponds to the vector function $\vec{u}$ @@ -1138,7 +1157,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void project_boundary_values_div_conforming (const DoFHandler &dof_handler, @@ -1153,7 +1173,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void project_boundary_values_div_conforming (const hp::DoFHandler &dof_handler, @@ -1224,7 +1245,8 @@ namespace VectorTools * are not set in the second operation on degrees of freedom that are * already constrained. This makes sure that the discretization remains * conforming as is needed. See the discussion on conflicting constraints in - * the module on @ref constraints . + * the module on + * @ref constraints. * * *

    Computing constraints in 2d

    @@ -1366,7 +1388,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template class DH, int spacedim> void @@ -1382,7 +1405,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template class DH, int spacedim> void @@ -1403,7 +1427,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template class DH, int spacedim> void @@ -1419,7 +1444,8 @@ namespace VectorTools * * @ingroup constraints * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template class DH, int spacedim> void @@ -1583,7 +1609,8 @@ namespace VectorTools * * See the general documentation of this class for further information. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void create_boundary_right_hand_side (const Mapping &mapping, @@ -1597,7 +1624,8 @@ namespace VectorTools * Calls the create_boundary_right_hand_side() function, see above, with * mapping=MappingQ1@(). * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void create_boundary_right_hand_side (const DoFHandler &dof, @@ -1609,7 +1637,8 @@ namespace VectorTools /** * Same as the set of functions above, but for hp objects. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void create_boundary_right_hand_side (const hp::MappingCollection &mapping, @@ -1624,7 +1653,8 @@ namespace VectorTools * single Q1 mapping as collection. This function therefore will only work * if the only active fe index in use is zero. * - * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" + * @see + * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators" */ template void create_boundary_right_hand_side (const hp::DoFHandler &dof, @@ -1697,8 +1727,11 @@ namespace VectorTools * the vector elements $d_K$ for an output vector with as many cells as * there are active cells of the triangulation object of the current * processor. However, not all active cells are in fact locally owned: some - * may be ghost or artificial cells (see @ref GlossGhostCell "here" and - * @ref GlossArtificialCell "here"). The vector computed will, in the case of + * may be ghost or artificial cells (see + * @ref GlossGhostCell "here" + * and + * @ref GlossArtificialCell "here" + * ). The vector computed will, in the case of * a distributed triangulation, contain zeros for cells that are not locally * owned. As a consequence, in order to compute the global $L_2$ * error (for example), the errors from different processors need to be @@ -1869,7 +1902,8 @@ namespace VectorTools * function using a Q1-mapping for cells. * * This function is used in the "Possibilities for extensions" part of the - * results section of @ref step_3 "step-3". + * results section of + * @ref step_3 "step-3". * * @note If the cell in which the point is found is not locally owned, an * exception of type VectorTools::ExcPointNotAvailableHere is thrown. @@ -1982,7 +2016,9 @@ namespace VectorTools * argument is used to denote which components of the solution vector * correspond to the pressure, and avoid touching all other components of * the vector, such as the velocity components. (Note, however, that the - * mask is not a @ref GlossComponentMask operating on the vector components + * mask is not a + * @ref GlossComponentMask + * operating on the vector components * of the finite element the solution vector @p v may be associated with; * rather, it is a mask on the entire vector, without reference to what the * vector elements mean.) @@ -2022,7 +2058,8 @@ namespace VectorTools * numerically using the quadrature formula given as third argument. * * This function is used in the "Possibilities for extensions" part of the - * results section of @ref step_3 "step-3". + * results section of + * @ref step_3 "step-3". * * @note The function is most often used when solving a problem whose * solution is only defined up to a constant, for example a pure Neumann -- 2.39.5