]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated function SparseILU::decompose. 495/head
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 4 Feb 2015 15:07:05 +0000 (09:07 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 4 Feb 2015 15:07:05 +0000 (09:07 -0600)
doc/news/changes.h
include/deal.II/lac/sparse_ilu.h
include/deal.II/lac/sparse_ilu.templates.h
source/lac/sparse_ilu.cc

index 7a53a1114ca8e3bfcef6373b6b4a9b67a281e845..0eda2920d142d0027581230cf2326a02002ffa0b 100644 (file)
@@ -148,7 +148,7 @@ inconvenience this causes.
   - The deprecated constructor of SparseILU.
   - SparseILU::apply_decomposition.
   - The deprecated constructor of SparseMIC.
-  - SparseMIC::decompose.
+  - SparseMIC::decompose and SparseILU::decompose.
   - The compress() functions without argument in the various vector
     classes. You should use the versions with a VectorOperation
     argument instead.
index df59dbe82533f3bf4d8c8026464e59749625dac1..d2e86ed571c69049eb2faf8dfad18198a1000914 100644 (file)
@@ -102,14 +102,6 @@ public:
   void initialize (const SparseMatrix<somenumber> &matrix,
                    const AdditionalData &parameters = AdditionalData());
 
-  /**
-   * @deprecated This method is deprecated, and left for backward compability.
-   * It will be removed in later versions.
-   */
-  template <typename somenumber>
-  void decompose (const SparseMatrix<somenumber> &matrix,
-                  const double                    strengthen_diagonal=0.) DEAL_II_DEPRECATED;
-
   /**
    * Apply the incomplete decomposition, i.e. do one forward-backward step
    * $dst=(LU)^{-1}src$.
index 913e84b372c6d86ecbdb682f6714b98de11ef53c..9c0c1faf33c23e1c54292707e1f09c4d60b2595a 100644 (file)
@@ -41,26 +41,16 @@ void SparseILU<number>::initialize (const SparseMatrix<somenumber> &matrix,
 {
   SparseLUDecomposition<number>::initialize(matrix, data);
 
-  decompose(matrix, data.strengthen_diagonal);
-}
-
-
-
-template <typename number>
-template <typename somenumber>
-void SparseILU<number>::decompose (const SparseMatrix<somenumber> &matrix,
-                                   const double strengthen_diagonal)
-{
   Assert (matrix.m()==matrix.n(), ExcNotQuadratic ());
   Assert (this->m()==this->n(),   ExcNotQuadratic ());
   Assert (matrix.m()==this->m(),  ExcDimensionMismatch(matrix.m(), this->m()));
 
-  Assert (strengthen_diagonal>=0,
-          ExcInvalidStrengthening (strengthen_diagonal));
+  Assert (data.strengthen_diagonal>=0,
+          ExcInvalidStrengthening (data.strengthen_diagonal));
 
-  SparseLUDecomposition<number>::decompose (matrix, strengthen_diagonal);
+  SparseLUDecomposition<number>::decompose (matrix, data.strengthen_diagonal);
 
-  if (strengthen_diagonal>0)
+  if (data.strengthen_diagonal>0)
     this->strengthen_diagonal_impl();
 
   // in the following, we implement algorithm 10.4 in the book by Saad by
@@ -145,7 +135,6 @@ label_200:
 
 
 
-
 template <typename number>
 template <typename somenumber>
 void SparseILU<number>::vmult (Vector<somenumber>       &dst,
index fd84976453de8fa57af065769927bd773f2ab593..035e0a9251c8bcd0bf3e69009af24c46cf15dfdf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -22,16 +22,12 @@ DEAL_II_NAMESPACE_OPEN
 template class SparseILU<double>;
 template void SparseILU<double>::initialize<double> (const SparseMatrix<double> &,
                                                      const AdditionalData &data);
-template void SparseILU<double>::decompose<double> (const SparseMatrix<double> &,
-                                                    const double);
 template void SparseILU<double>::vmult <double> (Vector<double> &,
                                                  const Vector<double> &) const;
 template void SparseILU<double>::Tvmult <double> (Vector<double> &,
                                                   const Vector<double> &) const;
 template void SparseILU<double>::initialize<float> (const SparseMatrix<float> &,
                                                     const AdditionalData &data);
-template void SparseILU<double>::decompose<float> (const SparseMatrix<float> &,
-                                                   const double);
 template void SparseILU<double>::vmult<float> (Vector<float> &,
                                                const Vector<float> &) const;
 template void SparseILU<double>::Tvmult<float> (Vector<float> &,
@@ -41,16 +37,12 @@ template void SparseILU<double>::Tvmult<float> (Vector<float> &,
 template class SparseILU<float>;
 template void SparseILU<float>::initialize<double> (const SparseMatrix<double> &,
                                                     const AdditionalData &data);
-template void SparseILU<float>::decompose<double> (const SparseMatrix<double> &,
-                                                   const double);
 template void SparseILU<float>::vmult<double> (Vector<double> &,
                                                const Vector<double> &) const;
 template void SparseILU<float>::Tvmult<double> (Vector<double> &,
                                                 const Vector<double> &) const;
 template void SparseILU<float>::initialize<float> (const SparseMatrix<float> &,
                                                    const AdditionalData &data);
-template void SparseILU<float>::decompose<float> (const SparseMatrix<float> &,
-                                                  const double);
 template void SparseILU<float>::vmult<float> (Vector<float> &,
                                               const Vector<float> &) const;
 template void SparseILU<float>::Tvmult<float> (Vector<float> &,

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.