From 7843ab77cd4fe604419d11959d8460095da1b59c Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Mon, 23 Feb 2015 16:06:01 -0500 Subject: [PATCH] manual edits to doxygen comments --- include/deal.II/base/point.h | 14 +++++--- include/deal.II/distributed/tria.h | 4 ++- include/deal.II/fe/fe_system.h | 2 +- include/deal.II/lac/block_matrix_array.h | 43 +++++++++++++++-------- include/deal.II/lac/lapack_full_matrix.h | 16 ++++++--- include/deal.II/lac/matrix_lib.h | 4 +-- include/deal.II/lac/pointer_matrix.h | 9 +++-- include/deal.II/lac/transpose_matrix.h | 3 +- include/deal.II/multigrid/mg_tools.h | 3 +- include/deal.II/numerics/data_out_stack.h | 3 -- 10 files changed, 66 insertions(+), 35 deletions(-) diff --git a/include/deal.II/base/point.h b/include/deal.II/base/point.h index d2e3925c7f..4a3a6cf919 100644 --- a/include/deal.II/base/point.h +++ b/include/deal.II/base/point.h @@ -67,7 +67,7 @@ DEAL_II_NAMESPACE_OPEN * consequently not be represented by either of these classes. Use an * array of size 3 in this case, or the std_cxx11::array * class. Alternatively, as in the case of vector-valued functions, - * you can use objects of type Vector or std::vector. + * you can use objects of type Vector or std::vector. * * * @tparam dim An integer that denotes the dimension of the space in which @@ -474,7 +474,8 @@ Point::serialize(Archive &ar, const unsigned int) /** - * Global operator scaling a point vector by a scalar. @relates Point + * Global operator scaling a point vector by a scalar. + * @relates Point */ template inline @@ -487,7 +488,8 @@ Point operator * (const Number factor, /** - * Global operator scaling a point vector by a scalar. @relates Point + * Global operator scaling a point vector by a scalar. + * @relates Point */ template inline @@ -501,7 +503,8 @@ Point operator * (const double factor, /** * Output operator for points. Print the elements consecutively, with a space - * in between. @relates Point + * in between. + * @relates Point */ template inline @@ -519,7 +522,8 @@ std::ostream &operator << (std::ostream &out, /** * Output operator for points. Print the elements consecutively, with a space - * in between. @relates Point + * in between. + * @relates Point */ template inline diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index a451d05253..735e1b0a83 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -182,7 +182,9 @@ namespace parallel * * @note This class does not support anisotropic refinement, because it * relies on the p4est library that does not support this. Attempts to - * refine cells anisotropically will result in errors. @note There is + * refine cells anisotropically will result in errors. + * + * @note There is * currently no support for distributing 1d triangulations. * * diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index eb842b97fe..69eaa0b52c 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -185,7 +185,7 @@ public: * @param[in] fe The finite element that will be used to represent * the components of this composed element. * @param[in] n_elements An integer denoting how many copies of - * @fe this element should consist of. + * @p fe this element should consist of. */ FESystem (const FiniteElement &fe, const unsigned int n_elements); diff --git a/include/deal.II/lac/block_matrix_array.h b/include/deal.II/lac/block_matrix_array.h index 320cbf7e0a..8c81eab915 100644 --- a/include/deal.II/lac/block_matrix_array.h +++ b/include/deal.II/lac/block_matrix_array.h @@ -77,9 +77,11 @@ template class Vector; * @dontinclude block_matrix_array.cc * * Obviously, we have to include the header file containing the definition of - * BlockMatrixArray: @skipline block_matrix_array.h + * BlockMatrixArray: + * @skipline block_matrix_array.h * - * First, we set up some matrices to be entered into the blocks. @skip main + * First, we set up some matrices to be entered into the blocks. + * @skip main * @until C.fill * * The BlockMatrixArray needs a VectorMemory<Vector<number> > @@ -90,18 +92,25 @@ template class Vector; * * @line Growing * - * Now, we are ready to build a 2x2 BlockMatrixArray. @line Block + * Now, we are ready to build a 2x2 BlockMatrixArray. + * @line Block * First, we enter the matrix A multiplied by 2 in the upper left - * block @line enter Now -1 times B1 in the upper right block. @line - * enter We add the transpose of B2 to the upper right block and + * block + * @line enter + * Now -1 times B1 in the upper right block. + * @line enter + * We add the transpose of B2 to the upper right block and * continue in a similar fashion. In the end, the block matrix structure is - * printed into an LaTeX table. @until latex + * printed into an LaTeX table. + * @until latex * * Now, we set up vectors to be multiplied with this matrix and do a - * multiplication. @until vmult + * multiplication. + * @until vmult * * Finally, we solve a linear system with BlockMatrixArray, using no - * preconditioning and the conjugate gradient method. @until Error + * preconditioning and the conjugate gradient method. + * @until Error * * The remaining code of this sample program concerns preconditioning and is * described in the documentation of BlockTrianglePrecondition. @@ -363,24 +372,30 @@ private: * * In order to set up the preconditioner, we have to compute the inverses of * the diagonal blocks ourselves. Since we used FullMatrix objects, this is - * fairly easy. @dontinclude block_matrix_array.cc @skip Error @until - * Cinv.invert + * fairly easy. + * @dontinclude block_matrix_array.cc + * @skip Error + * @until Cinv.invert * * After creating a 2x2 BlockTrianglePrecondition object, we only fill * its diagonals. The scaling factor 1/2 used for A is the * reciprocal of the scaling factor used for the matrix itself. * Remember, this preconditioner actually multiplies with the diagonal - * blocks. @until Cinv + * blocks. + * @until Cinv * * Now, we have a block Jacobi preconditioner, which is still symmetric, since * the blocks are symmetric. Therefore, we can still use the preconditioned - * conjugate gradient method. @until Error + * conjugate gradient method. + * @until Error * * Now, we enter the subdiagonal block. This is the same as in - * matrix. @until B2 + * matrix. + * @until B2 * * Since the preconditioner is not symmetric anymore, we use the GMRES method - * for solving. @until Error + * for solving. + * @until Error * * * @ingroup Preconditioners diff --git a/include/deal.II/lac/lapack_full_matrix.h b/include/deal.II/lac/lapack_full_matrix.h index 5ec1306431..851d526d48 100644 --- a/include/deal.II/lac/lapack_full_matrix.h +++ b/include/deal.II/lac/lapack_full_matrix.h @@ -95,7 +95,9 @@ public: operator = (const LAPACKFullMatrix &); /** - * Assignment operator from a regular FullMatrix. @note Since LAPACK expects + * Assignment operator from a regular FullMatrix. + * + * @note Since LAPACK expects * matrices in transposed order, this transposition is included here. */ template @@ -103,7 +105,9 @@ public: operator = (const FullMatrix &); /** - * Assignment operator from a regular SparseMatrix. @note Since LAPACK + * Assignment operator from a regular SparseMatrix. + * + * @note Since LAPACK * expects matrices in transposed order, this transposition is included * here. */ @@ -143,13 +147,17 @@ public: const size_type cols); /** - * Return the dimension of the range space. @note The matrix is of dimension + * Return the dimension of the range space. + * + * @note The matrix is of dimension * $m \times n$. */ unsigned int m () const; /** - * Return the number of the range space. @note The matrix is of dimension $m + * Return the number of the range space. + * + * @note The matrix is of dimension $m * \times n$. */ unsigned int n () const; diff --git a/include/deal.II/lac/matrix_lib.h b/include/deal.II/lac/matrix_lib.h index 019fbf500b..405902c27b 100644 --- a/include/deal.II/lac/matrix_lib.h +++ b/include/deal.II/lac/matrix_lib.h @@ -41,8 +41,8 @@ template class SparseMatrix; * stack products of three or more matrices by making one of the two matrices * an object of the current type handles be a ProductMatrix itself. * - * Here is an example multiplying two different FullMatrix objects: @include - * product_matrix.cc + * Here is an example multiplying two different FullMatrix objects: + * @include product_matrix.cc * * @author Guido Kanschat, 2000, 2001, 2002, 2005 */ diff --git a/include/deal.II/lac/pointer_matrix.h b/include/deal.II/lac/pointer_matrix.h index 15c4391f9e..c95f3f4c7e 100644 --- a/include/deal.II/lac/pointer_matrix.h +++ b/include/deal.II/lac/pointer_matrix.h @@ -159,7 +159,8 @@ public: /** * Assign a new matrix pointer. Deletes the old pointer and releases its - * matrix. @see SmartPointer + * matrix. + * @see SmartPointer */ const PointerMatrix &operator= (const MATRIX *M); @@ -268,7 +269,8 @@ public: /** * Assign a new matrix pointer. Deletes the old pointer and releases its - * matrix. @see SmartPointer + * matrix. + * @see SmartPointer */ const PointerMatrixAux &operator= (const MATRIX *M); @@ -374,7 +376,8 @@ public: /** * Assign a new matrix pointer. Deletes the old pointer and releases its - * matrix. @see SmartPointer + * matrix. + * @see SmartPointer */ const PointerMatrixVector &operator= (const Vector *M); diff --git a/include/deal.II/lac/transpose_matrix.h b/include/deal.II/lac/transpose_matrix.h index 20c3c2290b..b941bc9c4c 100644 --- a/include/deal.II/lac/transpose_matrix.h +++ b/include/deal.II/lac/transpose_matrix.h @@ -73,7 +73,8 @@ public: /** * Assign a new matrix pointer. Deletes the old pointer and releases its - * matrix. @see SmartPointer + * matrix. + * @see SmartPointer */ const TransposeMatrix &operator= (const MATRIX *M); diff --git a/include/deal.II/multigrid/mg_tools.h b/include/deal.II/multigrid/mg_tools.h index a6a69dfe6f..3430fd6bd6 100644 --- a/include/deal.II/multigrid/mg_tools.h +++ b/include/deal.II/multigrid/mg_tools.h @@ -89,7 +89,8 @@ namespace MGTools /** * Make a sparsity pattern including fluxes of discontinuous Galerkin - * methods. @see + * methods. + * @see * @ref make_sparsity_pattern * and * @ref DoFTools diff --git a/include/deal.II/numerics/data_out_stack.h b/include/deal.II/numerics/data_out_stack.h index 128c27a632..dd5a029f6a 100644 --- a/include/deal.II/numerics/data_out_stack.h +++ b/include/deal.II/numerics/data_out_stack.h @@ -220,9 +220,6 @@ public: * the general documentation of this class. An example is also provided in * the documentation of this class's base class DataOut_DoFData. * - * @param n_patches_per_circle Denotes into how many intervals - * the angular (rotation) variable is to be subdivided. - * * @param n_subdivisions See DataOut::build_patches() for an extensive * description of this parameter. The number of subdivisions is always * one in the direction of the time-like parameter used by this class. -- 2.39.5