From: Timo Heister Date: Fri, 26 Dec 2014 10:38:25 +0000 (-0500) Subject: manually reformat some files X-Git-Tag: v8.3.0-rc1~582^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=e5321d1195901aecf188c8b08ad4f5edf048c0cb;p=dealii.git manually reformat some files --- diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index afae9ff3da..6ace785bb4 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -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 */ diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index e39b71e38c..26e75ce5f8 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -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 void diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 4c6e375dff..4ac3c50189 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -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 > & 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; diff --git a/include/deal.II/fe/fe_abf.h b/include/deal.II/fe/fe_abf.h index db8d90b925..80d52095f6 100644 --- a/include/deal.II/fe/fe_abf.h +++ b/include/deal.II/fe/fe_abf.h @@ -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); diff --git a/include/deal.II/fe/fe_bdm.h b/include/deal.II/fe/fe_bdm.h index 97a66d2ee1..529e85f472 100644 --- a/include/deal.II/fe/fe_bdm.h +++ b/include/deal.II/fe/fe_bdm.h @@ -99,8 +99,7 @@ private: * Initialize the FiniteElement::generalized_support_points and * FiniteElement::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); /** diff --git a/include/deal.II/fe/fe_dg_vector.h b/include/deal.II/fe/fe_dg_vector.h index f4744ee735..5e59433035 100644 --- a/include/deal.II/fe/fe_dg_vector.h +++ b/include/deal.II/fe/fe_dg_vector.h @@ -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); diff --git a/include/deal.II/fe/fe_nedelec.h b/include/deal.II/fe/fe_nedelec.h index 815d1edc0a..1360c36392 100644 --- a/include/deal.II/fe/fe_nedelec.h +++ b/include/deal.II/fe/fe_nedelec.h @@ -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; diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h index b36415216f..6d2ca819e8 100644 --- a/include/deal.II/fe/fe_raviart_thomas.h +++ b/include/deal.II/fe/fe_raviart_thomas.h @@ -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); }; diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 61a306f995..aa7a372540 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -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 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 diff --git a/include/deal.II/grid/tria_accessor.h b/include/deal.II/grid/tria_accessor.h index 3c6a265a1c..102f0de28b 100644 --- a/include/deal.II/grid/tria_accessor.h +++ b/include/deal.II/grid/tria_accessor.h @@ -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. diff --git a/include/deal.II/grid/tria_levels.h b/include/deal.II/grid/tria_levels.h index 476a3fb367..86a7f742f0 100644 --- a/include/deal.II/grid/tria_levels.h +++ b/include/deal.II/grid/tria_levels.h @@ -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. */ diff --git a/include/deal.II/lac/block_sparsity_pattern.h b/include/deal.II/lac/block_sparsity_pattern.h index 07588a7c80..ec3fde6926 100644 --- a/include/deal.II/lac/block_sparsity_pattern.h +++ b/include/deal.II/lac/block_sparsity_pattern.h @@ -485,7 +485,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. * * Note: 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. diff --git a/include/deal.II/lac/compressed_set_sparsity_pattern.h b/include/deal.II/lac/compressed_set_sparsity_pattern.h index a5e87114d2..3e4c20cbd5 100644 --- a/include/deal.II/lac/compressed_set_sparsity_pattern.h +++ b/include/deal.II/lac/compressed_set_sparsity_pattern.h @@ -82,7 +82,8 @@ template class SparseMatrix; *

Notes

* * There are several, exchangeable variations of this class, see - * @ref Sparsity , section '"Dynamic" or "compressed" sparsity patterns' for + * @ref Sparsity, + * section '"Dynamic" or "compressed" sparsity patterns' for * more information. * * This class is a variation of the CompressedSparsityPattern class. Instead @@ -92,7 +93,7 @@ template 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 diff --git a/include/deal.II/lac/compressed_simple_sparsity_pattern.h b/include/deal.II/lac/compressed_simple_sparsity_pattern.h index 74712d4d1f..ea1a3bc67c 100644 --- a/include/deal.II/lac/compressed_simple_sparsity_pattern.h +++ b/include/deal.II/lac/compressed_simple_sparsity_pattern.h @@ -82,7 +82,8 @@ template class SparseMatrix; *

Notes

* * There are several, exchangeable variations of this class, see - * @ref Sparsity , section '"Dynamic" or "compressed" sparsity patterns' for + * @ref Sparsity, + * section '"Dynamic" or "compressed" sparsity patterns' for * more information. * * @author Timo Heister, 2008 diff --git a/include/deal.II/lac/compressed_sparsity_pattern.h b/include/deal.II/lac/compressed_sparsity_pattern.h index fe37d85b14..10451ce762 100644 --- a/include/deal.II/lac/compressed_sparsity_pattern.h +++ b/include/deal.II/lac/compressed_sparsity_pattern.h @@ -85,7 +85,8 @@ template class SparseMatrix; *

Notes

* * There are several, exchangeable variations of this class, see - * @ref Sparsity , section '"Dynamic" or "compressed" sparsity patterns' for + * @ref Sparsity, + * section '"Dynamic" or "compressed" sparsity patterns' for * more information. * * @author Wolfgang Bangerth, 2001 diff --git a/include/deal.II/lac/constraint_matrix.h b/include/deal.II/lac/constraint_matrix.h index 93ae59ff3a..be9621938d 100644 --- a/include/deal.II/lac/constraint_matrix.h +++ b/include/deal.II/lac/constraint_matrix.h @@ -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". */ diff --git a/include/deal.II/lac/matrix_block.h b/include/deal.II/lac/matrix_block.h index 049b59f82f..5a390981ed 100644 --- a/include/deal.II/lac/matrix_block.h +++ b/include/deal.II/lac/matrix_block.h @@ -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 diff --git a/include/deal.II/lac/parallel_vector.h b/include/deal.II/lac/parallel_vector.h index b02a14ad96..7fba3db664 100644 --- a/include/deal.II/lac/parallel_vector.h +++ b/include/deal.II/lac/parallel_vector.h @@ -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 * update_ghost_values() function imports the data from the * owning processor to the ghost indices in order to provide read access * to the data associated with ghosts. - It is possible to split the above diff --git a/include/deal.II/lac/petsc_block_sparse_matrix.h b/include/deal.II/lac/petsc_block_sparse_matrix.h index 51c9e4c8ca..d1910090d5 100644 --- a/include/deal.II/lac/petsc_block_sparse_matrix.h +++ b/include/deal.II/lac/petsc_block_sparse_matrix.h @@ -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 diff --git a/include/deal.II/lac/petsc_block_vector.h b/include/deal.II/lac/petsc_block_vector.h index 759e1976bd..4aee490945 100644 --- a/include/deal.II/lac/petsc_block_vector.h +++ b/include/deal.II/lac/petsc_block_vector.h @@ -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 diff --git a/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h b/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h index b535a8ce72..7f09c734a6 100644 --- a/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h +++ b/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h @@ -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 diff --git a/include/deal.II/lac/slepc_solver.h b/include/deal.II/lac/slepc_solver.h index 6a36bbf1a6..51a9348bdc 100644 --- a/include/deal.II/lac/slepc_solver.h +++ b/include/deal.II/lac/slepc_solver.h @@ -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 * diff --git a/include/deal.II/lac/trilinos_block_sparse_matrix.h b/include/deal.II/lac/trilinos_block_sparse_matrix.h index 347b84db90..6139035e23 100644 --- a/include/deal.II/lac/trilinos_block_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_block_sparse_matrix.h @@ -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 diff --git a/include/deal.II/numerics/data_out_rotation.h b/include/deal.II/numerics/data_out_rotation.h index 2476eeb6c4..5beeaa5f19 100644 --- a/include/deal.II/numerics/data_out_rotation.h +++ b/include/deal.II/numerics/data_out_rotation.h @@ -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); /**