]> https://gitweb.dealii.org/ - dealii.git/commitdiff
put @ref in separate line
authorTimo Heister <timo.heister@gmail.com>
Thu, 25 Dec 2014 20:00:11 +0000 (15:00 -0500)
committerMatthias Maier <tamiko@kyomu.43-1.org>
Fri, 26 Dec 2014 12:49:58 +0000 (13:49 +0100)
98 files changed:
include/deal.II/base/derivative_form.h
include/deal.II/base/exceptions.h
include/deal.II/base/function.h
include/deal.II/base/geometry_info.h
include/deal.II/base/graph_coloring.h
include/deal.II/base/index_set.h
include/deal.II/base/iterator_range.h
include/deal.II/base/multithread_info.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/qprojector.h
include/deal.II/base/quadrature.h
include/deal.II/base/types.h
include/deal.II/base/work_stream.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_iterator_selector.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/block_mask.h
include/deal.II/fe/component_mask.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_abf.h
include/deal.II/fe/fe_base.h
include/deal.II/fe/fe_dgp.h
include/deal.II/fe/fe_dgp_monomial.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_dgq.h
include/deal.II/fe/fe_face.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_nothing.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_q_iso_q1.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_update_flags.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/fe_values_extractors.h
include/deal.II/fe/mapping.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_in.h
include/deal.II/grid/grid_out.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_iterator_selector.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/mapping_collection.h
include/deal.II/hp/q_collection.h
include/deal.II/lac/block_indices.h
include/deal.II/lac/block_matrix.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/compressed_set_sparsity_pattern.h
include/deal.II/lac/compressed_simple_sparsity_pattern.h
include/deal.II/lac/compressed_sparsity_pattern.h
include/deal.II/lac/constraint_matrix.h
include/deal.II/lac/householder.h
include/deal.II/lac/matrix_lib.h
include/deal.II/lac/parallel_block_vector.h
include/deal.II/lac/parallel_vector.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/schur_matrix.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/sparse_direct.h
include/deal.II/lac/sparse_ilu.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/swappable_vector.h
include/deal.II/lac/trilinos_block_vector.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/trilinos_vector_base.h
include/deal.II/lac/vector.h
include/deal.II/meshworker/assembler.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_dof_iterator_selector.h
include/deal.II/multigrid/mg_tools.h
include/deal.II/numerics/data_out_rotation.h
include/deal.II/numerics/error_estimator.h
include/deal.II/numerics/fe_field_function.h
include/deal.II/numerics/point_value_history.h
include/deal.II/numerics/vector_tools.h

index 792692f972099551ea765808e615a0ab93aff759..edfe8ed62c93660dc6f03eb4de1d677918c01708 100644 (file)
@@ -383,6 +383,7 @@ DerivativeForm<order, dim, spacedim>::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 <int dim, int spacedim>
index 62642a789b5dbcac1f32427ebba8405271f421ea..765a630b8092bb55331ef8a2df9efcd9f480f993 100644 (file)
@@ -31,7 +31,9 @@ DEAL_II_NAMESPACE_OPEN
  * subject to change. Rather create new exception classes using the
  * <tt>DeclException</tt> 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
index 4d62a580f429f1c2ca48c5fe2b8bf96ca58006af..378bdda82952cf08c8f0595127cac3b67fced85e 100644 (file)
@@ -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
index 597acce7415c83f7c4fa1e5eaf7c5380db8898ef..a883e846efc8eecba2dd5a031e37826e3cbca579 100644 (file)
@@ -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
  * <em>Moebius</em>-loops, a face might even be rotated looking from one cell,
@@ -1112,8 +1114,8 @@ struct GeometryInfo<0>
  * This information is available as the <tt>line_orientation</tt> 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".
  *
  *
  * <h4>Children</h4>
@@ -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 <tt>true</tt>, <tt>face_flip</tt> and <tt>face_rotation</tt>
    * default to <tt>false</tt> (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, <tt>face_ref_case</tt>, might have an
@@ -1593,8 +1597,9 @@ struct GeometryInfo
    * the standard and non-standard orientation. <tt>face_orientation</tt>
    * defaults to <tt>true</tt>, <tt>face_flip</tt> and <tt>face_rotation</tt>
    * default to <tt>false</tt> (standard orientation). In 2d only
-   * <tt>face_flip</tt> is considered. See this @ref GlossFaceOrientation
-   * "glossary" article for more information.
+   * <tt>face_flip</tt> 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 <int spacedim>
   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];
 
index fa68060fc0c888428ee6de7aaf8b6fcf7e0f362c..c0977418738b1a0883eecefb74bab9588e4fcd08 100644 (file)
@@ -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.
index cab8e7081d0bbc3b3f48eb8a0b108c8196a0bad5..4061ecd74d3c103302ee7cc00ebe671056b20cdb 100644 (file)
@@ -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
  */
index bad89e2038b2754915b06d318663e33069524726..914db74eb08fbac544c26f9fa1b32b7b9d9f0c13 100644 (file)
@@ -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:
index 165e63f27734867d984228f173de0c38f79a7e07..b54e480587a236bb61b3d3e0151be9cec1592a57 100644 (file)
@@ -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 <code> multithread_info.n_cpus;
index 250be624d21a0953b3ce2f4bbdebe30dbc4cc6c1..365359474dd21abb2ba1fc54f67e811140d06dd3 100644 (file)
@@ -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 <tt>"red|blue|black"</tt>, then the @ref match function returns
+   * is <tt>"red|blue|black"</tt>, then the
+   * @ref match
+   * function returns
    * <tt>true</tt> 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.
  *
  * <h3>Declaring entries</h3>
index 18d399338cff3cbc8c8b2e18855ca2671c67ffaf..e2d699310d9329d28e2d1975ef65fc5dd94aab87 100644 (file)
@@ -63,8 +63,9 @@ DEAL_II_NAMESPACE_OPEN
  * <tt>cell->face_orientation(face)</tt>), 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.
  *
index 52829c729c2157df3873c4c7337c590de8f62a1c..4e29ae44937c9686c08d1e6178da3a100583b2bb 100644 (file)
@@ -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
  */
index 9e3bdb09d494a68d55c77ca815b26a803008227f..54fd11fda7d1db9bbbbb546fa603642cf8cbbfe3 100644 (file)
@@ -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<types::boundary_id>(-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<types::boundary_id>(-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<types::manifold_id>(-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<types::manifold_id>(-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<types::subdomain_id>(-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<types::subdomain_id>(-2);
 }
index ee63fab329b87d41dda70ab26b329e3aa6f8c89c..ad57d94635a399f65a481c78d310b2471c800a86 100644 (file)
@@ -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,
index 680eb6eea213a40f311d20404e3de98c7d866854..3733a9aed543d2048e90992850c8e01a07679475 100644 (file)
@@ -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.
index abd63aca1c6a1e944a7e159f839368accba25e86..33ebd56a74c2e53e25585e1aa4376b66a941f1b4 100644 (file)
@@ -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
-   * <i>active</i> objects (see @ref GlossActive "this glossary entry").
+   * <i>active</i> 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
-   * <i>active</i> objects (see @ref GlossActive "this glossary entry").
+   * <i>active</i> 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
-   * <i>active</i> objects (see @ref GlossActive "this glossary entry").
+   * <i>active</i> 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,
index a666adfe3aa737abab7f701af8dc2baf6360316d..0fd4c2249e474d9da0124ba0a94871ae8d69e491 100644 (file)
@@ -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 <a href="http://en.wikipedia.org/wiki/C%2B%2B11
@@ -673,7 +681,8 @@ public:
    * the global number of degrees of freedom, accumulated over all processors.
    *
    * In either case, included in the returned number are those DoFs which are
-   * constrained by hanging nodes, see @ref constraints.
+   * constrained by hanging nodes, see
+   * @ref constraints.
    */
   types::global_dof_index n_dofs () const;
 
@@ -712,7 +721,9 @@ public:
    * Access to an object informing of the block structure of the dof handler.
    *
    * If an FESystem is used in distribute_dofs(), degrees of freedom naturally
-   * split into several @ref GlossBlock "blocks". For each base element as
+   * split into several
+   * @ref GlossBlock "blocks".
+   * For each base element as
    * many blocks appear as its multiplicity.
    *
    * At the end of distribute_dofs(), the number of degrees of freedom in each
index dd66957e7b0a84816a6d30da6f7218664fd136eb..64ee1d52143f09e843eb16b464f2b69594745820 100644 (file)
@@ -47,7 +47,9 @@ namespace internal
      *
      * The types have the same meaning as those declared in
      * internal::Triangulation::Iterators<1,spacedim>, 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
index 908856f13d02a86ca2cd7dfaab1e25b3a9ff6553..61e9709403caa334e96985f122cacafc78919c86 100644 (file)
@@ -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
index b58895a56bf5a1debac8937d795c7b51b69207a4..04ffebd007da18c5e9427237bf3e36bc22121f5d 100644 (file)
@@ -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<typename DH>
@@ -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 <em>one</em> 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 <em>all</em> 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 <tt>dof_handler.n_dofs()</tt>. 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 <class DH>
   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 <class DH>
   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 <class DH>
   void
@@ -1362,7 +1390,8 @@ namespace DoFTools
   /**
    * Extract a vector that represents the constant modes of the DoFHandler for
    * the components chosen by <tt>component_mask</tt> (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
-   * <tt>component_mask</tt> (see @ref GlossComponentMask), each of which will
+   * <tt>component_mask</tt> (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 <class DH>
   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 <class DH>
   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 <int dim, int spacedim, template <int, int> class DH>
   void
index b036fb954a48a04a2478834b2f687f335eaa7b21..ae82b2fc488ba2d87e94c121fed6d0ab76499dc1 100644 (file)
@@ -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
  * <code>operator[]</code> 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<dim> stokes_fe (FESystem<dim>(FE_Q<dim>(2), dim), 1,    // Q2 element for the velocities
  *                            FE_Q<dim>(1),                     1);     // Q1 element for the pressure
index 8b564380840bc8dd4173233832a2d9334a2adca5..8797a06bac80522d967cda8768364b96d1cd7d4b 100644 (file)
@@ -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 <code>operator[]</code> 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<dim> stokes_fe (FE_Q<dim>(2), dim,    // Q2 element for the velocities
  *                            FE_Q<dim>(1), 1);     // Q1 element for the pressure
index fa61caf638f64c9ca25751f20d4f0d997390bd62..3a9064a27b100fb6777f01b9b59471de1115f74d 100644 (file)
@@ -75,14 +75,19 @@ namespace hp
  * <h3>Components and blocks</h3>
  *
  * 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
  * <h3>Support points</h3>
  *
  * 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<unsigned int, unsigned int>
@@ -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 <code>dim</code> 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 <code>dim*(dim+1)/2</code> 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 <code>dim</code> 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 <code>dim*(dim+1)/2</code> 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.
index 9be270709de7885f39a35f35b4cf70d1317d04a8..dd1b41dc0838d58ca4ac79f59bba12846110f28d 100644 (file)
@@ -60,7 +60,9 @@ template <int dim, int spacedim> class MappingQ;
  *
  * <h3>Interpolation</h3>
  *
- * 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 <int dim, int spacedim> class MappingQ;
  *
  * <h4>Node values on edges/faces</h4>
  *
- * 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
  * <i>k</i> on an edge/face is the space <i>Q<sub>k</sub></i>, the moments are
index 2bd0a73768534b4eae8bb8bc192a973036792a9b..b8dd096f43a05478056505c2b74b6887e319995d 100644 (file)
@@ -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
    * <code>FESystem(FE_Q(2),1,FE_Q(1),1)</code>) 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);
 
index 8f6471da11afa2325c0c67bb70863ec118410281..3739d19b16b0f7e23872e2217752c6cfcc83af1e 100644 (file)
@@ -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
index 56aab7b93922ab509c39296a0d5c12ea8c2ec8b3..e2f8c6dddfd9c4ba74a65a31f4175dd0c613e46e 100644 (file)
@@ -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
index 4a2dcf46c5b0dedb5408014a64577b36c1721f98..a1294a25a0d69072edea2ab0cacd7753dd78130c 100644 (file)
@@ -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
index bf996354e342ddd4cb84acf324add4e0cecc7fcc..31010002fbfcc374aba60e85ae239365733bc15d 100644 (file)
@@ -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
index ecedda82bce1d02154ffc8c0e1661b3e6a48ca76..21d231b4049214268d81cc5031f528b4ab7ffc55 100644 (file)
@@ -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
index 1a96a05eb3041d16dc284dc870a52aa1136ff836..bb7fce2c5aab9b4253258a8bc30106f1f1d91eb8 100644 (file)
@@ -119,7 +119,9 @@ template <int dim, int spacedim> class MappingQ;
  *
  * <h3>Interpolation</h3>
  *
- * The @ref GlossInterpolation "interpolation" operators associated with the
+ * The
+ * @ref GlossInterpolation "interpolation"
+ * operators associated with the
  * N&eacute;d&eacute;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 <int dim, int spacedim> class MappingQ;
  *
  * <h4>Node values</h4>
  *
- * The @ref GlossNodes "node values" for an element of degree <i>k</i> on the
+ * The
+ * @ref GlossNodes "node values"
+ * for an element of degree <i>k</i> on the
  * reference cell are:
  * <ol>
  * <li> On edges: the moments of the tangential component with respect to
index 21624e675c3e8d1e133027205de147c117b61192..25719d02c89792853d23d35b26b5cd73cfc896c4 100644 (file)
@@ -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
index 61165e8fad7d5c22d6c0d6c3c4d461f82a23ca39..e9b2c478a85338be5b157370f4f90980662fe642 100644 (file)
@@ -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
index 96d15f165605bc78ca8baa57edc831915f4dc454..722a60605412d5000af0fecf1cdc4529fc30768e 100644 (file)
@@ -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
index e01d09e3ddb30c9b1daad179a67f021fe54d8255..991432491beb099040d7493474927023165b6885 100644 (file)
@@ -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
index e0085465185eaa82ec11ea9ea0d9231cf1837bf2..d76c663f4c5e4e3ceb78837aed6b4fe0cfc1992b 100644 (file)
@@ -66,7 +66,9 @@ template <int dim, int spacedim> class MappingQ;
  *
  * <h3>Interpolation</h3>
  *
- * 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 <int dim, int spacedim> class MappingQ;
  *
  * <h4>Node values on edges/faces</h4>
  *
- * 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
  * <i>k</i> on an edge/face is the space <i>Q<sub>k</sub></i>, the moments are
index aa6b6b42613641d81699351c84eba6f518322ae9..3b9e4951aa7dedcba3354eddfb2e86461afc9770 100644 (file)
@@ -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.
  *
  * <h3>FESystem, components and blocks</h3>
  *
@@ -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
index 6968f55cce9d6c4b3126f5e85ebe686dd42c1eb7..06dec8c9d25d575deb87f1821a6f0d1f889930e9 100644 (file)
@@ -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
    */
index f438a71a64a612f79452cb44fd80180923994c93..cdd55c28565257203e1afc601c44bb63fd0ede83 100644 (file)
@@ -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
 {
index 1ff5ddc59b2e4913ceb9273656143691eeddf68c..bc3502a893b27e4e391faa05d9079e3daf7c7534 100644 (file)
@@ -120,7 +120,9 @@ namespace internal
  * order tensor components consisting of <code>(dim*dim + dim)/2</code>
  * 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 <code>spacedim</code> 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 <code>spacedim</code> components that behave in specific
@@ -731,7 +736,9 @@ namespace FEValuesViews
   /**
    * A class representing a view to a set of <code>(dim*dim + dim)/2</code>
    * 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 <code>dim*dim</code> 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<dim,spacedim> &
   operator[] (const FEValuesExtractors::Scalar &scalar) const;
@@ -2261,7 +2272,8 @@ public:
    * Create a view of the current FEValues object that represents a set of
    * <code>dim</code> 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<dim,spacedim> &
@@ -2272,7 +2284,9 @@ public:
    * <code>(dim*dim + dim)/2</code> 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:
    * <code>(dim*dim)</code> 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 <tt>i</tt>th
-   * quadrature point.  See @ref GlossBoundaryForm .
+   * quadrature point.  See
+   * @ref GlossBoundaryForm.
    *
    * @dealiiRequiresUpdateFlags{update_boundary_forms}
    */
index 813e8f315e6987c3be65a91c69abbe6683e0e27c..8a87a4051298053013584d563bf3d72fad60675a 100644 (file)
@@ -32,7 +32,9 @@ DEAL_II_NAMESPACE_OPEN
  * <code>dim</code> elements, and second order symmetric tensors consisting of
  * <code>(dim*dim + dim)/2</code> 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 <code>spacedim</code> 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
    *
index a6279429c2b5c68328c12d5f939b6405d5929abb..53cb2f00bac7d0461d42c771a303109eb99ab164 100644 (file)
@@ -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
index e04361debab7323d69c135614db3923c9b1d626d..0199828d5731ef995afed64114bda880fb3f40aa 100644 (file)
@@ -38,7 +38,8 @@ template <typename number> 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
index 9dfdb09768294a7437624cd78b61892b5281f901..9a9fd0083c21dd60235e03225219dc57126505d0 100644 (file)
@@ -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
index cc53ae816befa075dd6bc2a2fce8bf20567af089..4c5d3635508251e47c36cce3f4eee98813c2efc0 100644 (file)
@@ -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;
 
index 8684e467788f8a1afb7f54c8bc3da081d339dbc3..5c6342527926bbead0eae5d5680eecffe36350f5 100644 (file)
@@ -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.
index c97b472a0700f4fe97009275f68dc77415e35f20..812341f2f08676442f3ef0bc045258c4e63cc0d6 100644 (file)
@@ -780,7 +780,8 @@ namespace internal
  * changed using a call of the kind
  * <code>cell-@>face(1)-@>set_boundary_indicator(42);</code>.
  *
- * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
+ * @see
+ * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
  *
  *
  * <h3>History of a triangulation</h3>
@@ -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 <tt>unsigned
  * int</tt> or a <tt>void *</tt>, for each line, quad, etc. You can access
  * these through the functions listed under <tt>User data</tt> 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".
  *
  *
  * <h3>Getting notice when a triangulation changes</h3>
@@ -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<dim,spacedim> &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<dim,spacedim> &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<dim,spacedim> &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<dim,spacedim> &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<types::boundary_id> 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<types::manifold_id> get_manifold_ids() const;
 
@@ -1800,7 +1816,9 @@ public:
    * If the <code>check_for_distorted_cells</code> 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<spacedim triangulation, see
-   * @ref GlossDirectionFlag .
+   * @ref GlossDirectionFlag.
    *
    * This function throws an exception if dim equals spacedim.
    */
@@ -2081,213 +2099,246 @@ public:
    */
 
   /**
-   * Clear all user flags.  See also @ref GlossUserFlags .
+   * Clear all user flags.  See also
+   * @ref GlossUserFlags.
    */
   void clear_user_flags ();
 
   /**
    * Save all user flags. See the general documentation for this class and the
    * documentation for the @p save_refine_flags for more details.  See also
-   * @ref GlossUserFlags .
+   * @ref GlossUserFlags.
    */
   void save_user_flags (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 (std::vector<bool> &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<bool> &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<bool> &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<bool> &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<bool> &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<bool> &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<bool> &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<bool> &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<unsigned int> &v) const;
 
   /**
    * Read the information stored by save_user_indices().  See also
-   * @ref GlossUserData .
+   * @ref GlossUserData.
    */
   void load_user_indices (const std::vector<unsigned int> &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<void *> &v) const;
 
   /**
    * Read the information stored by save_user_pointers().  See also
-   * @ref GlossUserData .
+   * @ref GlossUserData.
    */
   void load_user_pointers (const std::vector<void *> &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<unsigned int> &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<unsigned int> &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<unsigned int> &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<unsigned int> &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<unsigned int> &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<unsigned int> &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<void *> &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<void *> &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<void *> &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<void *> &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<void *> &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<void *> &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 <a href="http://en.wikipedia.org/wiki/C%2B%2B11
@@ -3087,7 +3139,9 @@ private:
    * <tt>dim=2,3</tt> and the <tt>quad->user_flags</tt> for <tt>dim=3</tt>.
    *
    * The function returns a list of cells that have produced children that
-   * satisfy the criteria of @ref GlossDistorted "distorted cells" if the
+   * satisfy the criteria of
+   * @ref GlossDistorted "distorted cells"
+   * if the
    * <code>check_for_distorted_cells</code> flag was specified upon creation
    * of this object, at
    */
index 7890ec676db2ee5a5c0ec7d4c547d7946994a6b0..f83671dc2289d3cd54e30b29f7053dd75f3d070c 100644 (file)
@@ -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
  * (<tt>structdim&lt;dim</tt>).
  *
  * 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. <tt>A
    * *a=static_cast<A*>(cell->user_pointer());</tt>.
    *
-   * 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 <code>!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 <code>!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 <code>!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;
   /**
index 355d62a1059843cad00bf5f9b7ff3538042115ff..df566bc945a4545a2b0c69d982e0dd06c532f509 100644 (file)
@@ -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
index b5b4ab5e562586caba9cbdb4f20112d33a7bc70d..36d48a77f10d9251a11d17612d499222a1d9f70e 100644 (file)
@@ -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".
    *
    *
    * <h3>Active FE indices and their behavior under mesh refinement</h3>
@@ -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 <a
@@ -487,7 +493,8 @@ namespace hp
      * processors.
      *
      * In either case, included in the returned number are those DoFs which
-     * are constrained by hanging nodes, see @ref constraints.
+     * are constrained by hanging nodes, see
+     * @ref constraints.
      */
     types::global_dof_index n_dofs () const;
 
index 213b488dd9fbfdf7f51d7e5807ce98af8db33feb..a0a5472433a7c159f14b1fecdf683a3c01307552 100644 (file)
@@ -32,8 +32,9 @@ namespace hp
    * hp::DoFHandler. It is thus to a hp::DoFHandler what a FiniteElement is to
    * a ::DoFHandler.
    *
-   * It implements the concepts stated in the @ref hpcollection module
-   * described in the doxygen documentation.
+   * It implements the concepts stated in the
+   * @ref hpcollection
+   * module described in the doxygen documentation.
    *
    * In addition to offering access to the elements of the collection, this
    * class provides access to the maximal number of degrees of freedom per
@@ -102,7 +103,8 @@ namespace hp
      * collection.
      *
      * This function calls FiniteElement::n_components.  See
-     * @ref GlossComponent "the glossary" for more information.
+     * @ref GlossComponent "the glossary"
+     * for more information.
      */
     unsigned int n_components () const;
 
@@ -112,7 +114,8 @@ namespace hp
      * have the same number of vector components, there is no such guarantees
      * for the number of blocks each element is made up of (an element may
      * have fewer blocks than vector components; see
-     * @ref GlossBlock "the glossary" for more information). For example,
+     * @ref GlossBlock "the glossary"
+     * for more information). For example,
      * you may have an FECollection object that stores one copy of an
      * FESystem with <code>dim</code> FE_Q objects and one copy of an
      * FE_RaviartThomas element. Both have <code>dim</code> 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 <code>dim</code> 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 <code>dim*(dim+1)/2</code>
      * 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.
index f81dcd2a25f186c2b2797dd728717840f86cdcd7..a11de61486c83f2d85398a336b611dd3e60530da 100644 (file)
@@ -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
index 270060b9b8e06153ce4266adf8664b64387159dd..5af55ae450d463584742c6da082195b367ba8d1f 100644 (file)
@@ -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
index 890d723935d6ec80f018d9264a4fb98c6f116030..f181b5f51584292b3415faa5a50c82461bfedb26 100644 (file)
@@ -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 <typename number>     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 <typename MatrixType>
index 18491b8c29a23cbff29dc6ef1537951441760787..139e97fbe62298fb641cedbdf9af7733cdf92661 100644 (file)
@@ -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 <class MATRIX>
index 44f91961428d6063913937f3a979d9107d48eed9..88cad408db2e0fd2616059ac87f291f1a640ff9b 100644 (file)
@@ -329,9 +329,12 @@ namespace BlockMatrixIterators
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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 <typename MatrixType>
@@ -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);
 
index 29fdddbc9d9ce8fcffd16f189e553050d3457cfa..c16afe17931a7fe879134828cc1a7b93c38b2b9a 100644 (file)
@@ -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 <typename number>
index afb566bad7731899ad45fc401b344f5a51c19ec5..449ec77d707ed6f80cbff201166df4809295d872 100644 (file)
@@ -44,7 +44,8 @@ template <typename Number> 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<typename Number>
index 1953611503670d13fa6e82bc854ca2c15f4c01e4..902ebbbcb108ce52fb16f8f5fe11552e2017ed99 100644 (file)
@@ -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 <class SparsityPatternBase>
@@ -294,7 +295,8 @@ public:
    * Print the sparsity of the matrix in a format that <tt>gnuplot</tt>
    * 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.
  *
  * <b>Note:</b> 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.
  *
  * <b>Note:</b> 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.
  *
- * <b>Note:</b> 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.
  *
- * <b>Note:</b> 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
index e22702c30b3f938f151b6f5d53b49b3a1dcfe1b3..68aae884960ec5c5e895a8306ebc75fc3f0a8b36 100644 (file)
@@ -51,9 +51,12 @@ namespace TrilinosWrappers
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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 <typename Number>
@@ -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
index 943100c2fc40bac22e64cb6236fddb9625bc7940..9b15eab2bcc7a84219a6e797b7e1167b8226a42e 100644 (file)
@@ -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 <class VectorType>
@@ -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);
 
index 2cdba2cacb8b8d772730f1fc4b200332fe18d104..acb85947c21138a273e9bdf03e6a91828ab27c8a 100644 (file)
@@ -399,7 +399,9 @@ namespace ChunkSparseMatrixIterators
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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.
index 913d30395a673a27f4898297214fe061fd291e36..7edecdbc5a942e760f76fe01555733fd6c9f824a 100644 (file)
@@ -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.
index 78760b48e1dbc0315db612a2c141ceb3fb6f238b..986a267ad961a32b2683b0b84b0d7d0a83002336 100644 (file)
@@ -48,11 +48,15 @@ template <typename number> 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.
  *
  * <h3>Interface</h3>
  *
@@ -81,7 +85,8 @@ template <typename number> class SparseMatrix;
  * <h3>Notes</h3>
  *
  * 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 <typename number> 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
index 9daa10aa372214fbf626024c10527917d2bf39da..5c5c8bc98d06ce2cd9c436602280e07514f4ce65 100644 (file)
@@ -51,10 +51,12 @@ template <typename number> 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.
  *
  * <h3>Interface</h3>
  *
@@ -81,7 +83,8 @@ template <typename number> class SparseMatrix;
  * <h3>Notes</h3>
  *
  * 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
index 410a911897bded2ad2017e4ff7e3be304c9f8123..5565304aa85d619c5c73cf3692f997c01a3d0299 100644 (file)
@@ -53,10 +53,12 @@ template <typename number> 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.
  *
  * <h3>Interface</h3>
  *
@@ -84,7 +86,8 @@ template <typename number> class SparseMatrix;
  * <h3>Notes</h3>
  *
  * 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
index 93984dde0618bb82e0c26de61ba981f41986add7..aeeaf9febdc42405477ed5418f48336668ceca57 100644 (file)
@@ -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 <i>M</i> other degrees of
@@ -79,8 +81,11 @@ namespace internals
  * <em>not</em> 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 <i>M. S.
+ * @ref hp_paper.
+ * The algorithms are also related to those shown in <i>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.</i>, 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
index d9cdcf313453633ddb869d76f4a15c905b2a347e..a2786d8c0be0349dcfef2e822cdc6978c95bbe22 100644 (file)
@@ -46,7 +46,9 @@ template<typename number> class Vector;
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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
  */
index 69880bdb1cb74560754c85626c15469a9a401d4f..c8546e3d1830573ad83c3a32d79eedb98aacdc2d 100644 (file)
@@ -403,7 +403,9 @@ private:
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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
  */
index 7ae703425128e1c84b0eb23fab3acb15f1990d09..2bb2f7a48de1218b857b4ec05304b12b8030af79 100644 (file)
@@ -51,9 +51,12 @@ namespace parallel
      *
      * @note Instantiations for this template are provided for <tt>@<float@>
      * and @<double@></tt>; 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 <typename Number>
@@ -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
index 56a1792582c9b4f07dae4927ac5decf4483bfc57..fd861dc5c36c86a1c787a701bdbd1b6933df6f10 100644 (file)
@@ -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
-     * <code>[my_first_index,my_last_index)</code>. - Ghost indices residing
+     * <code>[my_first_index,my_last_index)</code>.
+     * - 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
      * <code>compress()</code> 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
      * <code>update_ghost_values()</code> 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
      * <code>operator = (0.)</code>), 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<Number> 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<Number> 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;
 
index 0b46f8945820b9ca7241c1bd1497327db31e8b67..53a5b18dfc9bc5c5202ba5bcdc3544b332c4c626 100644 (file)
@@ -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);
 
index 68be3bb698d012be52577faefe6e1a64df20117f..36c848e6f639ca96b2c84adb9c0aea451c81b70b 100644 (file)
@@ -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<Vector>
index 0def3db8b18e7c8a6bbccd6bf60eb0c21384d128..d528e8d9980674711fa499fa5e8ccc9e262f8e1c 100644 (file)
@@ -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
index bee40b44e8192ce9d297abec1cbe1c679df5be6b..a6f3392a24c09c79efd9cfde5dd499ba3b84df33 100644 (file)
@@ -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;
 
index 0f2c85345e8b220b954e731fc2c20dbdf95dadc1..4496c7ab2e0f123dfa10b6701d8755084f467e7c 100644 (file)
@@ -75,7 +75,8 @@ class PreconditionBlockJacobi;
  * for example, <tt>number==double, inverse_type=float</tt> 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 <tt>@<float@> and
  * @<double@></tt>; 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 <tt>@<float@> and
  * @<double@></tt>; 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 <tt>@<float@> and
  * @<double@></tt>; 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
  */
index b6596d743ecdcdcaf59f15efcc8f690da69bb415..6bef61a7143fdc16a391bf020fe1030787f9d9d5 100644 (file)
@@ -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 <class MA_inverse, class MB, class MDt, class MC>
index fc589ebf758a6a3dde23b56cd04327d79b1735af..7855ac189a4a23e52ec574d169d309fb6c8bcc0e 100644 (file)
@@ -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
  *
index f066f7b06229c39345631a2658ac5c41234ad890..d485b273fe9ddb8a5918dd1460a6e28b41d754b9 100644 (file)
@@ -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
index b5bb0b366ae5ae3e37a870536af953824be44fe0..fb72d42d69d8c9397f48b357d0917d8ddc571778 100644 (file)
@@ -44,12 +44,15 @@ DEAL_II_NAMESPACE_OPEN
  * <h3>Usage and state management</h3>
  *
  * 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 <tt>@<float@> and
  * @<double@></tt>; 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
  */
index 2407dfe73b3b522b313f69ec49ded3da326938f0..83ca387baad89c12f470d4b131408db77eec1a62 100644 (file)
@@ -480,7 +480,9 @@ namespace SparseMatrixIterators
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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.
index a4fc54216017b8e0eb905f4123d2021a5b372be8..2fb44cf8aed741d62a1ecd37d8ccbec93ba49060 100644 (file)
@@ -122,7 +122,9 @@ template <typename number> class SparseBlockVanka;
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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
  */
index 55ed83f778863b2344ab0f8c2667f0a528c4f350..ee4295367c9a050b4ceedee72192b5b4f50aaa26 100644 (file)
@@ -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
  */
index 6b21f8203b9e6df03ab65e68cc8c78a52261c34b..bd2734ac1d528073a2d15712e285a02a9c9430f9 100644 (file)
@@ -46,7 +46,9 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @note Instantiations for this template are provided for <tt>@<float@> and
  * @<double@></tt>; 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
  */
index 1422247e697e4a16f513a76154d7a116753d1d20..e8e4a4eb4d3dc153a4878691ad37207bdc3a2322 100644 (file)
@@ -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<Vector>
@@ -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;
 
index 21941e90673d9f1d029beddc2f5e88413378bd9a..1bb4e6cb42473b22d34d20eb53e3cb884199e4b5 100644 (file)
@@ -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;
 
index e124590219b49cc4fe4b4b916226008b6ca0c353..52e351840805eab5ab046f3765303890c058eca9 100644 (file)
@@ -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);
 
index 93e8ace3cf67a7fe48205c2ea65b05bc16acb19f..b904a01f9bb2d7bada1a22949e134e0ae1054675 100644 (file)
@@ -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 &parallel_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 &parallel_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 <typename number>
       void reinit (const Epetra_Map             &parallel_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 &parallel_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 <typename Number>
       Vector (const Epetra_Map             &parallel_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 &parallel_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   &parallel_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 <typename Number>
       Vector (const IndexSet               &parallel_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 &parallel_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,
index bc71a473540d070db1406c2a37b025d18ba9162c..9235eec0deff00d6d58dbec4abbb78b842cabfdf 100644 (file)
@@ -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;
 
index 12451ed13a8d65ecf7d840df26d450e5e6f27433..176a7524644d9a8fcf3ae1db5cf5f5eefd1aed22 100644 (file)
@@ -75,8 +75,9 @@ template <typename> 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
  * @<double@>, @<long double@>, @<std::complex@<float@>@>,
  * @<std::complex@<double@>@>, @<std::complex@<long double@>@></tt>; 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
  */
index 90f3818c6a899bc0c67aeaa4aeb99d60663dcbeb..7c3b413d0eb31a221b7408177163771489613a3d 100644 (file)
@@ -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.
index 838cf27386fb62da41f2a628ff3e2c42d09a6708..b5bc701ee6e73c377c2206d7db3cafc3b5088013 100644 (file)
@@ -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
index 56e4b05f0ead7f534a5b7d1617e4d24979978493..cf39a9c26d8ebcdeaf750c79fdad7fb9d535d628 100644 (file)
@@ -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 <int spacedim>
@@ -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 <int spacedim>
@@ -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 <int spacedim>
index 097af48ce236f3a0ddde2b6aeb8900ea04958860..0023c22b779e14dd98aff33e110c0653a6651f43 100644 (file)
@@ -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 <int dim, class SparsityPattern, int spacedim>
   void
index c32261a021504a112f8b2da5a77b9db2b2629363..42811fe2a4557c004227f8d1578d715532592001 100644 (file)
@@ -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 ();
index 2cf43e70b58f9ad22c200add4a6f00f0e68495b6..1a3f4e95976c3471c14ecba452bb1a216ea41b05 100644 (file)
@@ -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.
index 0c1b9dd6bc1900e815959d6c8d0b6b1225d4ae9d..ff5ad91d94eacc86ba31de501f48c1567185f84e 100644 (file)
@@ -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<dim> &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<Point< dim > >     &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<Point< dim > >     &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
index d393a64ac965065172ed3a4a1424f947d9f948f5..6fa4e445d0f91f6f058204b233d31dd768c0093a 100644 (file)
@@ -102,13 +102,16 @@ namespace internal
  * <ol>
  * <li>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
  * </ol>
  *
  * 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
index 87181b23fe49fe21d8287dbdaacb3fe30728c440..c0c8f52c84a0a85507b7658143cac7ad77858c0f 100644 (file)
@@ -311,7 +311,9 @@ class ConstraintMatrix;
  * @note Instantiations for this template are provided for some vector types,
  * in particular <code>Vector&lt;float&gt;, Vector&lt;double&gt;,
  * BlockVector&lt;float&gt;, BlockVector&lt;double&gt;</code>; 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 <class DH>
   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 <class DH>
   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 <class DH>
   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 <class DH>
   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 <int dim>
   void project_boundary_values_curl_conforming (const DoFHandler<dim> &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 <int dim>
   void project_boundary_values_curl_conforming (const hp::DoFHandler<dim> &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<int dim>
   void project_boundary_values_div_conforming (const DoFHandler<dim> &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<int dim>
   void project_boundary_values_div_conforming (const hp::DoFHandler<dim> &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.
    *
    *
    * <h4>Computing constraints in 2d</h4>
@@ -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 <int dim, template <int, int> 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 <int dim, template <int, int> 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 <int dim, template <int, int> 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 <int dim, template <int, int> 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 <int dim, int spacedim>
   void create_boundary_right_hand_side (const Mapping<dim,spacedim>      &mapping,
@@ -1597,7 +1624,8 @@ namespace VectorTools
    * Calls the create_boundary_right_hand_side() function, see above, with
    * <tt>mapping=MappingQ1@<dim@>()</tt>.
    *
-   * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
+   * @see
+   * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
   template <int dim, int spacedim>
   void create_boundary_right_hand_side (const DoFHandler<dim,spacedim>   &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 <int dim, int spacedim>
   void create_boundary_right_hand_side (const hp::MappingCollection<dim,spacedim>      &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 <int dim, int spacedim>
   void create_boundary_right_hand_side (const hp::DoFHandler<dim,spacedim>   &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 <i>global</i> $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

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.