]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Update documentation in a number of places and make a parameter a reference.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 18 Jan 2013 00:47:05 +0000 (00:47 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 18 Jan 2013 00:47:05 +0000 (00:47 +0000)
git-svn-id: https://svn.dealii.org/trunk@28113 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/lac/sparse_decomposition.h
deal.II/include/deal.II/lac/sparse_ilu.h
deal.II/include/deal.II/lac/sparse_ilu.templates.h
deal.II/include/deal.II/lac/sparse_mic.h
deal.II/include/deal.II/lac/sparse_mic.templates.h

index 17e25c9bd79ac066bdd2811ad53e7910ae756c31..3f3d9cf42a0ad8ec0b00adb90a9c02972d34c388 100644 (file)
@@ -25,8 +25,8 @@ DEAL_II_NAMESPACE_OPEN
  */
 
 /**
- * Abstract base class for sparse LU decompositions of a sparse matrix
- * into another sparse matrix. This class can't be used by itself, but
+ * Abstract base class for incomplete decompositions of a sparse matrix
+ * into sparse factors. This class can't be used by itself, but
  * only as the base class of derived classes that actually implement
  * particular decompositions such as SparseILU or SparseMIC.
  *
@@ -39,10 +39,11 @@ DEAL_II_NAMESPACE_OPEN
  *
  * <h3>Fill-in</h3>
  *
- * The sparse LU decompositions are frequently used with additional
- * fill-in, i.e. the sparsity structure of the decomposition is denser
+ * Sparse decompositions are frequently used with additional
+ * fill-in, i.e., the sparsity structure of the decomposition is denser
  * than that of the matrix to be decomposed. The initialize()
- * function of this class allows this fill-in as long as all entries
+ * function of this class allows this fill-in via the AdditionalData
+ * object as long as all entries
  * present in the original matrix are present in the decomposition
  * also, i.e. the sparsity pattern of the decomposition is a superset
  * of the sparsity pattern in the original matrix.
@@ -148,10 +149,12 @@ protected:
   SparseLUDecomposition ();
 
   /**
-   * This method is deprecated, and
+   * @deprecated This method is deprecated, and
    * left for backward
-   * compability. It will be removed
+   * compatibility. It will be removed
    * in later versions.
+   * Instead, pass the sparsity pattern that you want used for
+   * the decomposition in the AdditionalData structure.
    */
   SparseLUDecomposition (const SparsityPattern &sparsity) DEAL_II_DEPRECATED;
 
index 900c85723253644bfbf598c609a18f6defd3deb9..8ad744ede8ab448612070665994b53ced8d307ea 100644 (file)
@@ -25,11 +25,12 @@ DEAL_II_NAMESPACE_OPEN
  */
 
 /**
- * Incomplete LU decomposition of a sparse matrix into another sparse matrix.
- * A given matrix is decomposed into a incomplete LU factorization, where
- * by incomplete we mean that also a sparse decomposition is used and entries
- * in the decomposition that do not fit into the sparsity structure of this
- * object are discarded.
+ * This class computes an Incomplete LU (ILU) decomposition of a sparse matrix,
+ * using either the same sparsity pattern or a different one.
+ * By incomplete we mean that unlike the exact decomposition, the incomplete
+ * one is also computed using sparse factors, and entries
+ * in the decomposition that do not fit into the given sparsity structure
+ * are discarded.
  *
  * The algorithm used by this class is essentially a copy of the
  * algorithm given in the book Y. Saad: "Iterative methods for sparse
@@ -62,10 +63,12 @@ public:
   SparseILU ();
 
   /**
-   * @deprecated This method is
-   * deprecated, and left for
-   * backward compability. It will
-   * be removed in later versions.
+   * @deprecated This method is deprecated, and
+   * left for backward
+   * compatibility. It will be removed
+   * in later versions.
+   * Instead, pass the sparsity pattern that you want used for
+   * the decomposition in the AdditionalData structure.
    */
   SparseILU (const SparsityPattern &sparsity) DEAL_II_DEPRECATED;
 
@@ -112,10 +115,10 @@ public:
    */
   template <typename somenumber>
   void initialize (const SparseMatrix<somenumber> &matrix,
-                   const AdditionalData parameters = AdditionalData());
+                   const AdditionalData &parameters = AdditionalData());
 
   /**
-   * This method is deprecated, and
+   * @deprecate This method is deprecated, and
    * left for backward
    * compability. It will be
    * removed in later versions.
index ff2ea3df130bfbc76e0256e5718763f11c5491ac..6bb71fa990bc110c5ea93e9840cc2e55caef269e 100644 (file)
@@ -40,7 +40,7 @@ SparseILU<number>::SparseILU (const SparsityPattern &sparsity) :
 template <typename number>
 template <typename somenumber>
 void SparseILU<number>::initialize (const SparseMatrix<somenumber> &matrix,
-                                    const AdditionalData data)
+                                    const AdditionalData &data)
 {
   SparseLUDecomposition<number>::initialize(matrix, data);
 
index f4ba0fbc2bb485941d35abdc0929d2dcbe8efd77..b250b3fb45365b2915ea61a05003469b9c1affdd 100644 (file)
@@ -28,11 +28,11 @@ DEAL_II_NAMESPACE_OPEN
  *
  * <h3>The decomposition</h3>
  *
- * Let a sparse matrix A is in the form A = - L - U + D, where -L and
- * -U are strictly lower and upper triangular matrices. The MIC(0)
- * decomposition of the matrix A is defined by B = (X-L)X^(-1)(X-U),
- * where X is a diagonal matrix, defined by the condition rowsum(A) =
- * rowsum(B).
+ * Let a sparse matrix $A$ be in the form $A = - L - U + D$, where $-L$ and
+ * $-U$ are strictly lower and upper triangular matrices. The MIC(0)
+ * decomposition of the matrix $A$ is defined by $B = (X-L)X^(-1)(X-U)$,
+ * where $X$ is a diagonal matrix, defined by the condition $\text{rowsum}(A) =
+ * \text{rowsum}(B)$.
  *
  * @author Stephen "Cheffo" Kolaroff, 2002, unified interface: Ralf
  * Hartmann 2003.
@@ -43,21 +43,23 @@ class SparseMIC : public SparseLUDecomposition<number>
 public:
   /**
    * Constructor. Does nothing, so
-   * you have to call @p reinit
+   * you have to call @p decompose
    * sometimes afterwards.
    */
   SparseMIC ();
 
   /**
-   * Constructor. Initialize the
-   * sparsity pattern of this
-   * object with the given
-   * argument.
+   * @deprecated This method is deprecated, and
+   * left for backward
+   * compatibility. It will be removed
+   * in later versions.
+   * Instead, pass the sparsity pattern that you want used for
+   * the decomposition in the AdditionalData structure.
    */
-  SparseMIC (const SparsityPattern &sparsity);
+  SparseMIC (const SparsityPattern &sparsity) DEAL_II_DEPRECATED;
 
   /**
-   * Destruction.
+   * Destructor.
    */
   virtual ~SparseMIC();
 
@@ -88,17 +90,45 @@ public:
   void reinit (const SparsityPattern &sparsity) DEAL_II_DEPRECATED;
 
   /**
-   * Same as @p decompose.
+   * Perform the incomplete LU
+   * factorization of the given
+   * matrix.
+   *
+   * This function needs to be
+   * called before an object of
+   * this class is used as
+   * preconditioner.
+   *
+   * For more details about
+   * possible parameters, see the
+   * class documentation of
+   * SparseLUDecomposition and the
+   * documentation of the
+   * @p SparseLUDecomposition::AdditionalData
+   * class.
+   *
+   * According to the
+   * @p parameters, this function
+   * creates a new SparsityPattern
+   * or keeps the previous sparsity
+   * or takes the sparsity given by
+   * the user to @p data. Then,
+   * this function performs the MIC
+   * decomposition.
+   *
+   * After this function is called
+   * the preconditioner is ready to
+   * be used.
    */
   template <typename somenumber>
   void initialize (const SparseMatrix<somenumber> &matrix,
-                   const AdditionalData parameters);
+                   const AdditionalData &parameters = AdditionalData());
 
   /**
-   * This method is deprecated, and
+   * @deprecate This method is deprecated, and
    * left for backward
    * compability. It will be
-   * removed in later versions.
+   * removed in later versions. Use initialize() instead.
    */
   template <typename somenumber>
   void decompose (const SparseMatrix<somenumber> &matrix,
index 4cf41a9c6bb21324cc7cd9fcb69c8af07791a207..9d9c98ff9231b0b9917ac152b16493db7a985715 100644 (file)
@@ -72,7 +72,7 @@ template <typename number>
 template <typename somenumber>
 inline
 void SparseMIC<number>::initialize (const SparseMatrix<somenumber> &matrix,
-                                    const AdditionalData data)
+                                    const AdditionalData &data)
 {
   SparseLUDecomposition<number>::initialize(matrix, data);
 

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.