]> https://gitweb.dealii.org/ - dealii.git/commitdiff
manually reformat some files
authorTimo Heister <timo.heister@gmail.com>
Fri, 26 Dec 2014 10:38:25 +0000 (05:38 -0500)
committerTimo Heister <timo.heister@gmail.com>
Fri, 26 Dec 2014 16:45:17 +0000 (11:45 -0500)
24 files changed:
include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_abf.h
include/deal.II/fe/fe_bdm.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_levels.h
include/deal.II/lac/block_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/matrix_block.h
include/deal.II/lac/parallel_vector.h
include/deal.II/lac/petsc_block_sparse_matrix.h
include/deal.II/lac/petsc_block_vector.h
include/deal.II/lac/petsc_parallel_block_sparse_matrix.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/numerics/data_out_rotation.h

index afae9ff3da2f784ca1e29afd9ce73aeeda0e2154..6ace785bb4dd8b29fef9f76331e4f5ed4a113ae6 100644 (file)
@@ -529,7 +529,7 @@ public:
   DeclException0 (ExcMatrixDoesNotMatch);
   /**
    * A function has been called for a cell which should be
-   * @ref GlossActive "active" , but is refined.
+   * @ref GlossActive "active", but is refined.
    *
    * @ingroup Exceptions
    */
@@ -999,7 +999,7 @@ public:
   DeclException0 (ExcMatrixDoesNotMatch);
   /**
    * A function has been called for a cell which should be
-   * @ref GlossActive "active" , but is refined.
+   * @ref GlossActive "active", but is refined.
    *
    * @ingroup Exceptions
    */
index e39b71e38c3242b219282e997c38cb98c0e1a21f..26e75ce5f83c63e1d6bf773ef0cb5f8ccd449400 100644 (file)
@@ -925,8 +925,7 @@ namespace DoFTools
    * interpolation matrix with size no_face_dofs $\times$ no_face_dofs.
    *
    * Detailed information can be found in the see
-   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
-   * conditions".
+   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions".
    *
    * @todo: Reference to soon be written example step and glossary article.
    *
@@ -963,8 +962,7 @@ namespace DoFTools
    * before.
    *
    * @see
-   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
-   * conditions" for further information.
+   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" for further information.
    *
    * @author Daniel Arndt, Matthias Maier, 2013, 2014
    */
@@ -1018,8 +1016,7 @@ namespace DoFTools
    * need more functionality use GridTools::collect_periodic_faces() directly.
    *
    * @see
-   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
-   * conditions" for further information.
+   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" for further information.
    *
    * @author Matthias Maier, 2012
    */
@@ -1056,8 +1053,7 @@ namespace DoFTools
    * need more functionality use GridTools::collect_periodic_faces() directly.
    *
    * @see
-   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
-   * conditions" for further information.
+   * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" for further information.
    */
   template<typename DH>
   void
index 4c6e375dffa24b8d8f6ce3730bb813862028f748..4ac3c50189a1abf079c3122bb4eb9efdcaa38686 100644 (file)
@@ -78,7 +78,7 @@ namespace hp
  * 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
+ * @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().
@@ -1458,8 +1458,7 @@ public:
    * Return a support point vector for generalized interpolation.
    *
    * See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized points" for more information.
    */
   const std::vector<Point<dim> > &
   get_generalized_support_points () const;
@@ -1469,8 +1468,7 @@ public:
    * get_unit_support_points() or get_generalized_support_points().
    *
    * See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
    */
   bool has_generalized_support_points () const;
 
index db8d90b925e13eb7ccc5672f9862f2d4d6e6c701..80d52095f65017d9cd55d03cc7aa6d38f1a754b4 100644 (file)
@@ -159,8 +159,7 @@ private:
    * and #interior_weights). Called from the constructor.
    *
    * See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
    */
   void initialize_support_points (const unsigned int rt_degree);
 
index 97a66d2ee1537cd6ef3422d3966442e8423d3461..529e85f47233124d9d84662cdcb99e70db0d0c95 100644 (file)
@@ -99,8 +99,7 @@ private:
    * Initialize the FiniteElement<dim>::generalized_support_points and
    * FiniteElement<dim>::generalized_face_support_points fields. Called from
    * the constructor. See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
    */
   void initialize_support_points (const unsigned int rt_degree);
   /**
index f4744ee735bb0ab565ca5ece12d0e3805e831475..5e5943303531cbd3c18a524638f5772e2ce3e542 100644 (file)
@@ -109,8 +109,7 @@ private:
    * constructor.
    *
    * See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
    */
   void initialize_support_points (const unsigned int degree);
 
index 815d1edc0aa6226f34102b2e535646b0c39fb9ab..1360c36392e33c822b69ed8c232bd9036a10b1e5 100644 (file)
@@ -383,8 +383,7 @@ private:
    * #generalized_face_support_points when computing the integration.
    *
    * See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
    */
   Table<2, double> boundary_weights;
 
index b36415216f7bfc2e2bcd2c7e6670ed3e44d44c2e..6d2ca819e8c99dfd2a4d9494ae147bea2101187e 100644 (file)
@@ -216,8 +216,7 @@ private:
    * point and one column for each degree of freedom on the face.
    *
    * See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
    */
   Table<2, double> boundary_weights;
   /**
@@ -357,8 +356,7 @@ private:
    * the constructor.
    *
    * See the
-   * @ref GlossGeneralizedSupport "glossary entry on generalized support
-   * points" for more information.
+   * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
    */
   void initialize_support_points (const unsigned int rt_degree);
 };
index 61a306f995ff4b9aaef9832a85c4b9c8d27fcfe4..aa7a372540486ef552fde44ea2d4ac0e517f74a8 100644 (file)
@@ -927,8 +927,7 @@ namespace GridTools
      * interpreted as an interpolation matrix with size no_face_dofs $\times$
      * no_face_dofs. For more details see make_periodicity_constraints() and
      * the glossary
-     * @ref GlossPeriodicConstraints "glossary entry on periodic boundary
-     * conditions".
+     * @ref GlossPeriodicConstraints "glossary entry on periodic conditions".
      */
     FullMatrix<double> matrix;
 
@@ -1060,8 +1059,7 @@ namespace GridTools
    * matrix is interpreted as a rotation matrix that is applied to all vector
    * valued blocks listed in @p first_vector_components of the FESystem. For
    * more details see make_periodicity_constraints() and the glossary
-   * @ref GlossPeriodicConstraints "glossary entry on periodic boundary
-   * conditions".
+   * @ref GlossPeriodicConstraints "glossary entry on periodic conditions".
    *
    * @tparam Container A type that satisfies the requirements of a mesh
    * container (see
@@ -1113,8 +1111,7 @@ namespace GridTools
    * matrix is interpreted as a rotation matrix that is applied to all vector
    * valued blocks listet in @p first_vector_components of the FESystem. For
    * more details see make_periodicity_constraints() and the glossary
-   * @ref GlossPeriodicConstraints "glossary entry on periodic boundary
-   * conditions".
+   * @ref GlossPeriodicConstraints "glossary entry on periodic conditions".
    *
    * @tparam Container A type that satisfies the requirements of a mesh
    * container (see
index 3c6a265a1c01d9e6b3ff83ea93269b3b03044beb..102f0de28b30d9bdc3211c30192bbfedc9eecbac 100644 (file)
@@ -958,7 +958,7 @@ public:
    * Return a constant reference to the manifold object used for this object.
    *
    * As explained in
-   * @ref boundary "Boundary and manifold description for triangulations" ,
+   * @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.
index 476a3fb367986ad7f90198bf579afa8eef90b3ae..86a7f742f005bebd3ef83e4de77ba942578bfe4a 100644 (file)
@@ -132,7 +132,7 @@ namespace internal
       /**
        * One bool per cell to indicate the direction of the normal true:  use
        * orientation from vertex false: revert the orientation. See
-       * @ref GlossDirectionFlag .
+       * @ref GlossDirectionFlag.
        *
        * This is only used for codim==1 meshes.
        */
index 07588a7c807bfa856939395ff1efdfe89433f531..ec3fde69262ebd709f3b52b887e68a99cc34ee94 100644 (file)
@@ -485,7 +485,7 @@ public:
  * @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.
@@ -604,7 +604,7 @@ typedef BlockCompressedSparsityPattern CompressedBlockSparsityPattern DEAL_II_DE
  * @ref Sparsity.
  *
  * @note There are several, exchangeable variations of this class, see
- * @ref Sparsity , section 'Dynamic block sparsity patterns' for more
+ * @ref Sparsity, section 'Dynamic block sparsity patterns' for more
  * information.
  *
  * @author Wolfgang Bangerth, 2007
@@ -684,7 +684,7 @@ public:
  * @ref Sparsity.
  *
  * @note There are several, exchangeable variations of this class, see
- * @ref Sparsity , section 'Dynamic block sparsity patterns' for more
+ * @ref Sparsity, section 'Dynamic block sparsity patterns' for more
  * information.
  *
  * This class is used in step-22 and step-31.
index a5e87114d2887b23fcaaf463a6a5991d586d7958..3e4c20cbd5e02e6a549bd829bed69c818293735e 100644 (file)
@@ -82,7 +82,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.
  *
  * This class is a variation of the CompressedSparsityPattern class. Instead
@@ -92,7 +93,7 @@ template <typename number> class SparseMatrix;
  * 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 benchmark where nonzero
+ * @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 the CompressedSparsityPattern
index 74712d4d1f6cfe81385c0d5ce9eb41ae16845d2a..ea1a3bc67c5381a8058f1d8829303522003b46ff 100644 (file)
@@ -82,7 +82,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 fe37d85b14d05b41374890faa572af3aeb5882d4..10451ce762713fdbad4d6475f5b378ea5e4aaabb 100644 (file)
@@ -85,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
+ * @ref Sparsity,
+ * section '"Dynamic" or "compressed" sparsity patterns' for
  * more information.
  *
  * @author Wolfgang Bangerth, 2001
index 93ae59ff3a8ef123e4a5dfb89f6a4d191f2e8c0c..be9621938dd3ef114c5950771d48315c11a45bde 100644 (file)
@@ -560,7 +560,7 @@ public:
    * 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
+   * @ref step_27 "step-27", or to use the CompressedSimpleSparsityPattern
    * class, see for example
    * @ref step_31 "step-31".
    */
index 049b59f82f630099919591f32a1dde71a440d184..5a390981ed957cd2a150e07c0a22a50b2044562e 100644 (file)
@@ -94,7 +94,10 @@ namespace internal
  * complement.
  *
  * @ingroup Matrix2
- * @ingroup vector_valued @see @ref GlossBlockLA "Block (linear algebra)"
+ * @ingroup vector_valued
+ *
+ * @see
+ * @ref GlossBlockLA "Block (linear algebra)"
  * @author Guido Kanschat, 2006
  */
 template <class MATRIX>
index b02a14ad9660a0ce2caf3bfd564abedb7803095b..7fba3db6642a991bcb898573432e7c15cf7a98ca 100644 (file)
@@ -82,9 +82,9 @@ namespace parallel
      * the partitioning is changed again. This allows for efficient 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"
-     * .) - Besides the usual global access operator () it is also possible to
+     * communication. For more information on ghost vectors, see also the
+     * @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
@@ -97,8 +97,8 @@ namespace parallel
      * assembly routine involving ghosts that fill this vector. Note that the
      * @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
+     * processor has set them to the desired value already (See also 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
index 51c9e4c8ca6dd80299ca418c5bde7dbe0165f01d..d1910090d508ae768b39b054cf88825889d975b2 100644 (file)
@@ -59,7 +59,9 @@ namespace PETScWrappers
    * function, for much the same reason as is documented with the
    * BlockSparsityPattern class.
    *
-   * @ingroup Matrix1 @see @ref GlossBlockLA "Block (linear algebra)"
+   * @ingroup Matrix1
+   * @see
+   * @ref GlossBlockLA "Block (linear algebra)"
    * @author Wolfgang Bangerth, 2004
    */
   class BlockSparseMatrix : public BlockMatrixBase<PETScWrappers::SparseMatrix>
index 759e1976bd8c87eb9f05d405632e19a1599a5103..4aee4909458750f985a6b121bd6e9a21180548d6 100644 (file)
@@ -43,7 +43,10 @@ namespace PETScWrappers
    * interface, this class handles the actual allocation of vectors and
    * provides functions that are specific to the underlying vector type.
    *
-   * @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 b535a8ce72aaba416deeff2fbe01b1894791ef20..7f09c734a6cde90cf17572001e3a8c634916c0b6 100644 (file)
@@ -61,7 +61,9 @@ namespace PETScWrappers
      * collect_sizes() function, for much the same reason as is documented
      * with the BlockSparsityPattern class.
      *
-     * @ingroup Matrix1 @see @ref GlossBlockLA "Block (linear algebra)"
+     * @ingroup Matrix1
+     * @see
+     * @ref GlossBlockLA "Block (linear algebra)"
      * @author Wolfgang Bangerth, 2004
      */
     class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
index 6a36bbf1a631ba4300fbdf2e4d1f15d105800b4a..51a9348bdc45ed4521efb76ee181d6d53360d495 100644 (file)
@@ -90,8 +90,10 @@ DEAL_II_NAMESPACE_OPEN
  * 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.
+ * @ref SLEPcWrappers "SLEPcWrappers",
+ * see also the
+ * @ref PETScWrappers "PETScWrappers",
+ * on which they depend.
  *
  * @ingroup SLEPcWrappers
  *
index 347b84db90dbb2f166652dd0440e72bba1d3c768..6139035e23def1315beb0204cd244b6a66a1b868 100644 (file)
@@ -69,7 +69,9 @@ namespace TrilinosWrappers
    * function, for much the same reason as is documented with the
    * BlockSparsityPattern class.
    *
-   * @ingroup Matrix1 @see @ref GlossBlockLA "Block (linear algebra)"
+   * @ingroup Matrix1
+   * @see
+   * @ref GlossBlockLA "Block (linear algebra)"
    * @author Martin Kronbichler, Wolfgang Bangerth, 2008
    */
   class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
index 2476eeb6c4e10348a338cc08b26bc6ada4947ffd..5beeaa5f191723ebc8f3c3e614a73fdebc44eece 100644 (file)
@@ -155,7 +155,7 @@ public:
   /**
    * Return the first cell which we want output for. The default
    * implementation returns the first
-   * @ref GlossActive "active cell" , but you might want to return other cells
+   * @ref GlossActive "active cell", but you might want to return other cells
    * in a derived class.
    */
   virtual cell_iterator first_cell ();
@@ -170,7 +170,7 @@ public:
    * guaranteed as long as @p first_cell is also used from the default
    * implementation. Overloading only one of the two functions might not be a
    * good idea.
-   */
+  */
   virtual cell_iterator next_cell (const cell_iterator &cell);
 
   /**

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.