]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Patch by Martin Genet: Better doxygen markup.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 4 May 2011 03:07:19 +0000 (03:07 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 4 May 2011 03:07:19 +0000 (03:07 +0000)
git-svn-id: https://svn.dealii.org/trunk@23679 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/lac/block_sparse_matrix.h
deal.II/include/deal.II/lac/sparse_matrix.h
deal.II/include/deal.II/lac/sparse_matrix_ez.h

index 699557df9a89dc47e6bc98eb6a529e46124ca51d..5b2d311512c34056ff2407aae5cfd57a0bd44d6f 100644 (file)
@@ -71,6 +71,10 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
     typedef typename BaseClass::iterator        iterator;
     typedef typename BaseClass::const_iterator  const_iterator;
 
+/**
+ * @name Constructors and initalization
+ */
+//@{
                                     /**
                                      * Constructor; initializes the
                                      * matrix to be empty, without
@@ -182,7 +186,12 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
                                      * set to zero by this function.
                                      */
     virtual void reinit (const BlockSparsityPattern &sparsity);
+//@}
 
+/**
+ * @name Information on the matrix
+ */
+//@{
                                     /**
                                      * Return whether the object is
                                      * empty. It is empty if either
@@ -218,6 +227,33 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
                                      */
     unsigned int n_actually_nonzero_elements (const double threshold = 0.0) const;
 
+                                     /**
+                                      * Return a (constant) reference
+                                      * to the underlying sparsity
+                                      * pattern of this matrix.
+                                      *
+                                      * Though the return value is
+                                      * declared <tt>const</tt>, you
+                                      * should be aware that it may
+                                      * change if you call any
+                                      * nonconstant function of
+                                      * objects which operate on it.
+                                      */
+    const BlockSparsityPattern &
+    get_sparsity_pattern () const;
+
+                                     /**
+                                      * Determine an estimate for the
+                                      * memory consumption (in bytes)
+                                      * of this object.
+                                      */
+    std::size_t memory_consumption () const;
+//@}
+
+/**
+ * @name Multiplications
+ */
+//@{
                                     /**
                                      * Matrix-vector multiplication:
                                      * let $dst = M*src$ with $M$
@@ -308,7 +344,12 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
     template <typename nonblock_number>
     void Tvmult (Vector<nonblock_number>       &dst,
                  const Vector<nonblock_number> &src) const;
+//@}
 
+/**
+ * @name Preconditioning methods
+ */
+//@{
                                     /**
                                      * Apply the Jacobi
                                      * preconditioner, which
@@ -340,7 +381,12 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
     void precondition_Jacobi (Vector<number2>       &dst,
                              const Vector<number2> &src,
                              const number           omega = 1.) const;
+//@}
 
+/**
+ * @name Input/Output
+ */
+//@{
                                     /**
                                      * Print the matrix in the usual
                                      * format, i.e. as a matrix and
@@ -388,30 +434,8 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
                          const unsigned int  width       = 0,
                          const char         *zero_string = " ",
                          const double        denominator = 1.) const;
-
-                                    /**
-                                     * Return a (constant) reference
-                                     * to the underlying sparsity
-                                     * pattern of this matrix.
-                                     *
-                                     * Though the return value is
-                                     * declared <tt>const</tt>, you
-                                     * should be aware that it may
-                                     * change if you call any
-                                     * nonconstant function of
-                                     * objects which operate on it.
-                                     */
-    const BlockSparsityPattern &
-    get_sparsity_pattern () const;
-
-                                    /**
-                                     * Determine an estimate for the
-                                     * memory consumption (in bytes)
-                                     * of this object.
-                                     */
-    std::size_t memory_consumption () const;
-
-                                    /** @addtogroup Exceptions
+//@}
+                                    /** @addtogroup Exceptions
                                      * @{ */
 
                                      /**
@@ -419,6 +443,7 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
                                       */
     DeclException0 (ExcBlockDimensionMismatch);
                                     //@}
+
   private:
                                     /**
                                      * Pointer to the block sparsity
index 19129650492fec835812d0c34c330b0904eddb88..d3ac858b034c01aaab8d710d15c53e3adacd19a7 100644 (file)
@@ -546,7 +546,7 @@ class SparseMatrix : public virtual Subscriptor
     };
 
 /**
- * @name Constructors and initalization.
+ * @name Constructors and initalization
  */
 //@{
                                     /**
index 25232fa98f5c0b847c44c49fcfe1198359c3d9dd..f9b607759878eb945ac38350a08a3220a3c5ef61 100644 (file)
@@ -329,7 +329,11 @@ class SparseMatrixEZ : public Subscriptor
                                      * the STL container classes.
                                      */
     typedef number value_type;
-    
+
+/**
+ * @name Constructors and initalization
+ */
+//@{
                                     /**
                                      * Constructor. Initializes an
                                      * empty matrix of dimension zero
@@ -427,7 +431,11 @@ class SparseMatrixEZ : public Subscriptor
                                      * its sparsity pattern.
                                      */
     void clear ();
-    
+//@}
+/**
+ * @name Information on the matrix
+ */
+//@{
                                     /**
                                      * Return whether the object is
                                      * empty. It is empty if
@@ -462,8 +470,50 @@ class SparseMatrixEZ : public Subscriptor
                       * elements of this matrix.
                       */                     
     unsigned int n_nonzero_elements () const;
-    
+
+                                    /**
+                                     * Determine an estimate for the
+                                     * memory consumption (in bytes)
+                                     * of this object.
+                                     */
+    std::size_t memory_consumption () const;
+
+                                    /**
+                                     * Print statistics. If @p full
+                                     * is @p true, prints a
+                                     * histogram of all existing row
+                                     * lengths and allocated row
+                                     * lengths. Otherwise, just the
+                                     * relation of allocated and used
+                                     * entries is shown.
+                                     */
+    template <class STREAM>
+    void print_statistics (STREAM& s, bool full = false);
+
                                     /**
+                                     * Compute numbers of entries.
+                                     *
+                                     * In the first three arguments,
+                                     * this function returns the
+                                     * number of entries used,
+                                     * allocated and reserved by this
+                                     * matrix.
+                                     *
+                                     * If the final argument is true,
+                                     * the number of entries in each
+                                     * line is printed as well.
+                                     */
+    void compute_statistics (unsigned int& used,
+                            unsigned int& allocated,
+                            unsigned int& reserved,
+                            std::vector<unsigned int>& used_by_line,
+                            const bool compute_by_line) const;
+//@}
+/**
+ * @name Modifying entries
+ */
+//@{
+                     /**
                                      * Set the element <tt>(i,j)</tt> to
                                      * @p value. Allocates the entry,
                                      * if it does not exist and
@@ -610,7 +660,7 @@ class SparseMatrixEZ : public Subscriptor
     template <class MATRIX>
     SparseMatrixEZ<number> &
     copy_from (const MATRIX &source);
-    
+
                                     /**
                                      * Add @p matrix scaled by
                                      * @p factor to this matrix.
@@ -625,7 +675,11 @@ class SparseMatrixEZ : public Subscriptor
     template <class MATRIX>
     void add (const number factor,
              const MATRIX &matrix);
-
+//@}
+/**
+ * @name Entry Access
+ */
+//@{
                                     /**
                                      * Return the value of the entry
                                      * (i,j).  This may be an
@@ -654,7 +708,11 @@ class SparseMatrixEZ : public Subscriptor
                                      */
     number el (const unsigned int i,
               const unsigned int j) const;
-
+//@}
+/**
+ * @name Multiplications
+ */
+//@{
                                     /**
                                      * Matrix-vector multiplication:
                                      * let $dst = M*src$ with $M$
@@ -697,12 +755,20 @@ class SparseMatrixEZ : public Subscriptor
     template <typename somenumber>
     void Tvmult_add (Vector<somenumber>       &dst,
                     const Vector<somenumber> &src) const;
-  
+//@}
+/**
+ * @name Matrix norms
+ */
+//@{
                                     /**
                                      * Frobenius-norm of the matrix.
                                      */
     number l2_norm () const;
-
+//@}
+/**
+ * @name Preconditioning methods
+ */
+//@{
                                     /**
                                      * Apply the Jacobi
                                      * preconditioner, which
@@ -766,7 +832,11 @@ class SparseMatrixEZ : public Subscriptor
     void conjugate_add (const MATRIXA& A,
                        const MATRIXB& B,
                        const bool transpose = false);
-    
+//@}
+/**
+ * @name Iterators
+ */
+//@{
                                     /**
                                      * STL-like iterator with the
                                      * first existing entry.
@@ -793,7 +863,11 @@ class SparseMatrixEZ : public Subscriptor
                                      * different from <tt>end()</tt>!
                                      */
     const_iterator end (const unsigned int r) const;
-    
+//@}
+/**
+ * @name Input/Output
+ */
+//@{
                                     /**
                                      * Print the matrix to the given
                                      * stream, using the format
@@ -876,46 +950,7 @@ class SparseMatrixEZ : public Subscriptor
                                      * more.
                                      */
     void block_read (std::istream &in);
-
-
-                                    /**
-                                     * Determine an estimate for the
-                                     * memory consumption (in bytes)
-                                     * of this object.
-                                     */
-    std::size_t memory_consumption () const;
-
-                                    /**
-                                     * Print statistics. If @p full
-                                     * is @p true, prints a
-                                     * histogram of all existing row
-                                     * lengths and allocated row
-                                     * lengths. Otherwise, just the
-                                     * relation of allocated and used
-                                     * entries is shown.
-                                     */
-    template <class STREAM>
-    void print_statistics (STREAM& s, bool full = false);
-
-                                    /**
-                                     * Compute numbers of entries.
-                                     *
-                                     * In the first three arguments,
-                                     * this function returns the
-                                     * number of entries used,
-                                     * allocated and reserved by this
-                                     * matrix.
-                                     *
-                                     * If the final argument is true,
-                                     * the number of entries in each
-                                     * line is printed as well.
-                                     */
-    void compute_statistics (unsigned int& used,
-                            unsigned int& allocated,
-                            unsigned int& reserved,
-                            std::vector<unsigned int>& used_by_line,
-                            const bool compute_by_line) const;
-                            
+//@}
     
                                     /** @addtogroup Exceptions
                                      * @{ */

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.