]> https://gitweb.dealii.org/ - dealii.git/commitdiff
manual edits to doxygen comments
authorTimo Heister <timo.heister@gmail.com>
Mon, 23 Feb 2015 21:06:01 +0000 (16:06 -0500)
committerTimo Heister <timo.heister@gmail.com>
Mon, 23 Feb 2015 21:20:26 +0000 (16:20 -0500)
include/deal.II/base/point.h
include/deal.II/distributed/tria.h
include/deal.II/fe/fe_system.h
include/deal.II/lac/block_matrix_array.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/matrix_lib.h
include/deal.II/lac/pointer_matrix.h
include/deal.II/lac/transpose_matrix.h
include/deal.II/multigrid/mg_tools.h
include/deal.II/numerics/data_out_stack.h

index d2e3925c7f376648fefec134767f6e4c695a6b9a..4a3a6cf91975f602d729cf9d769c8a7606f9b37b 100644 (file)
@@ -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 <code>std_cxx11::array</code>
  * class. Alternatively, as in the case of vector-valued functions,
- * you can use objects of type Vector or <code>std::vector<code>.
+ * you can use objects of type Vector or <code>std::vector</code>.
  *
  *
  * @tparam dim An integer that denotes the dimension of the space in which
@@ -474,7 +474,8 @@ Point<dim,Number>::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 <int dim, typename Number>
 inline
@@ -487,7 +488,8 @@ Point<dim,Number> 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 <int dim>
 inline
@@ -501,7 +503,8 @@ Point<dim,double> operator * (const double             factor,
 
 /**
  * Output operator for points. Print the elements consecutively, with a space
- * in between. @relates Point
+ * in between.
+ * @relates Point
  */
 template <int dim, typename Number>
 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 <int dim, typename Number>
 inline
index a451d052539ef6532b4b07e43040eca238284391..735e1b0a83b3e11ba29146edb1153655a5ae977d 100644 (file)
@@ -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.
      *
      *
index eb842b97fe29f5e355be63adae52b1f55925f892..69eaa0b52ca465d4b9d0bfbdf83126776e1dc75a 100644 (file)
@@ -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.
+   *   @fe this element should consist of.
    */
   FESystem (const FiniteElement<dim,spacedim> &fe,
             const unsigned int n_elements);
index 320cbf7e0ad5ff32bce6d14c9b090b203a9e0755..8c81eab91511ba364f281d5de0af9b544788ff86 100644 (file)
@@ -77,9 +77,11 @@ template <typename> 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&lt;Vector&lt;number&gt; &gt;
@@ -90,18 +92,25 @@ template <typename> class Vector;
  *
  * @line Growing
  *
- * Now, we are ready to build a <i>2x2</i> BlockMatrixArray. @line Block
+ * Now, we are ready to build a <i>2x2</i> BlockMatrixArray.
+ * @line Block
  * First, we enter the matrix <tt>A</tt> multiplied by 2 in the upper left
- * block @line enter Now -1 times <tt>B1</tt> in the upper right block. @line
- * enter We add the transpose of <tt>B2</tt> to the upper right block and
+ * block
+ * @line enter
+ * Now -1 times <tt>B1</tt> in the upper right block.
+ * @line enter
+ * We add the transpose of <tt>B2</tt> 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 <i>2x2</i> BlockTrianglePrecondition object, we only fill
  * its diagonals. The scaling factor <i>1/2</i> used for <tt>A</tt> is the
  * reciprocal of the scaling factor used for the <tt>matrix</tt> itself.
  * Remember, this preconditioner actually <b>multiplies</b> 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
- * <tt>matrix</tt>. @until B2
+ * <tt>matrix</tt>.
+ * @until B2
  *
  * Since the preconditioner is not symmetric anymore, we use the GMRES method
- * for solving. @until Error
+ * for solving.
+ * @until Error
  *
  *
  * @ingroup Preconditioners
index 5ec1306431875f03dce2da73090ebb152547e6dd..851d526d48095b470cc6bff41d3765c1aae3d068 100644 (file)
@@ -95,7 +95,9 @@ public:
   operator = (const LAPACKFullMatrix<number> &);
 
   /**
-   * 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 <typename number2>
@@ -103,7 +105,9 @@ public:
   operator = (const FullMatrix<number2> &);
 
   /**
-   * 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;
index 019fbf500b3fbec548e3a4636a06fad668450644..405902c27bc3a517bbce265e9cbd1f08e464631e 100644 (file)
@@ -41,8 +41,8 @@ template<typename number> 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
  */
index 15c4391f9e8489442439fdd5f33a0dafdc25cdae..c95f3f4c7e293a46cd2db92f58afb8505afba377 100644 (file)
@@ -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<number> *M);
 
index 20c3c2290b0b05b65adeef3a365aa093f06a6f4f..b941bc9c4cbb2bb63a96578451468997a44ff015 100644 (file)
@@ -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);
 
index a6a69dfe6ff85d4ebea9a4e158a2f52e22ae0db3..3430fd6bd62c02be7485cc1ff3fa70264f96e685 100644 (file)
@@ -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
index 128c27a632d37e9b0848d70206eb5dff313954ba..dd5a029f6ae087dabc7896250c0d39f3ca38fa0a 100644 (file)
@@ -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.

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.