]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated function SparseMIC::decompose. 493/head
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 3 Feb 2015 17:27:31 +0000 (11:27 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 3 Feb 2015 17:27:31 +0000 (11:27 -0600)
doc/news/changes.h
include/deal.II/lac/sparse_mic.h
include/deal.II/lac/sparse_mic.templates.h
source/lac/sparse_mic.cc

index 6a3a88197705e572c32df22c903fef4fa8e91b54..6f4719b35a1522109518f6caa3deb9a79c0af177 100644 (file)
@@ -148,6 +148,7 @@ inconvenience this causes.
   - The deprecated constructor of SparseILU.
   - SparseILU::apply_decomposition.
   - The deprecated constructor of SparseMIC.
+  - SparseMIC::decompose.
   - The compress() functions without argument in the various vector
     classes. You should use the versions with a VectorOperation
     argument instead.
index 80c276b94cc82ae669dcfceb2bea46e7b2160bcc..aefa5923c7d393bd1f9eba635534d760e4268b99 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. Use initialize() instead.
-   */
-  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 c5168be157edaa7aaeb51883b36bb432222f4207..3ed279ba20877ce376ade4c9fdd6d4b58af0d939 100644 (file)
@@ -68,47 +68,15 @@ void SparseMIC<number>::initialize (const SparseMatrix<somenumber> &matrix,
 {
   SparseLUDecomposition<number>::initialize(matrix, data);
 
-  decompose(matrix, data.strengthen_diagonal);
-}
-
-
-
-template <typename number>
-void SparseMIC<number>::reinit (const SparsityPattern &sparsity)
-{
-  {
-    std::vector<number> tmp;
-    tmp.swap (diag);
-  }
-  {
-    std::vector<number> tmp;
-    tmp.swap (inv_diag);
-  }
-  {
-    std::vector<number> tmp;
-    tmp.swap (inner_sums);
-  }
-
-  SparseMatrix<number>::reinit(sparsity);
-  this->decomposed = false;
-}
-
-
-
-template <typename number>
-template <typename somenumber>
-void SparseMIC<number>::decompose (const SparseMatrix<somenumber> &matrix,
-                                   const double                    strengthen_diagonal)
-{
-  SparseLUDecomposition<number>::decompose(matrix, strengthen_diagonal);
+  SparseLUDecomposition<number>::decompose(matrix, data.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));
 
-  if (strengthen_diagonal > 0)
+  if (data.strengthen_diagonal > 0)
     this->strengthen_diagonal_impl ();
 
   // MIC implementation: (S. Margenov lectures)
@@ -150,6 +118,28 @@ void SparseMIC<number>::decompose (const SparseMatrix<somenumber> &matrix,
 
 
 
+template <typename number>
+void SparseMIC<number>::reinit (const SparsityPattern &sparsity)
+{
+  {
+    std::vector<number> tmp;
+    tmp.swap (diag);
+  }
+  {
+    std::vector<number> tmp;
+    tmp.swap (inv_diag);
+  }
+  {
+    std::vector<number> tmp;
+    tmp.swap (inner_sums);
+  }
+
+  SparseMatrix<number>::reinit(sparsity);
+  this->decomposed = false;
+}
+
+
+
 template <typename number>
 inline number
 SparseMIC<number>::get_rowsum (const size_type row) const
index 89c1c92d96cc2a84a1b7586a1559ffecc0f09e78..eb3e2e6d13a1d364fcc06bb1e8cba0d459af0b0a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2014 by the deal.II authors
+// Copyright (C) 2002 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -23,28 +23,20 @@ DEAL_II_NAMESPACE_OPEN
 template class SparseMIC<double>;
 template void SparseMIC<double>::initialize<double> (const SparseMatrix<double> &,
                                                      const AdditionalData &data);
-template void SparseMIC<double>::decompose<double> (const SparseMatrix<double> &,
-                                                    const double);
 template void SparseMIC<double>::vmult<double> (Vector<double> &,
                                                 const Vector<double> &) const;
 template void SparseMIC<double>::initialize<float> (const SparseMatrix<float> &,
                                                     const AdditionalData &data);
-template void SparseMIC<double>::decompose<float> (const SparseMatrix<float> &,
-                                                   const double);
 template void SparseMIC<double>::vmult<float> (Vector<float> &,
                                                const Vector<float> &) const;
 
 template class SparseMIC<float>;
 template void SparseMIC<float>::initialize<double> (const SparseMatrix<double> &,
                                                     const AdditionalData &data);
-template void SparseMIC<float>::decompose<double> (const SparseMatrix<double> &,
-                                                   const double);
 template void SparseMIC<float>::vmult<double> (Vector<double> &,
                                                const Vector<double> &) const;
 template void SparseMIC<float>::initialize<float> (const SparseMatrix<float> &,
                                                    const AdditionalData &data);
-template void SparseMIC<float>::decompose<float> (const SparseMatrix<float> &,
-                                                  const double);
 template void SparseMIC<float>::vmult<float> (Vector<float> &,
                                               const Vector<float> &) const;
 

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.