]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated function SparseLUDecomposition::decompose.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 24 Feb 2015 03:23:27 +0000 (21:23 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 24 Feb 2015 03:23:27 +0000 (21:23 -0600)
doc/news/changes.h
include/deal.II/lac/sparse_decomposition.h
include/deal.II/lac/sparse_decomposition.templates.h
include/deal.II/lac/sparse_ilu.templates.h
include/deal.II/lac/sparse_mic.templates.h
source/lac/sparse_decomposition.cc

index d6145a7c0c4b4295c8290612258cdd14bdafe04e..692cd913d093435f03ab66c51dd3d655c14cfe5a 100644 (file)
@@ -163,6 +163,7 @@ inconvenience this causes.
   - SparseMIC::decompose and SparseILU::decompose.
   - SparseMIC::reinit and SparseLUDecomposition::reinit.
   - SparseILU::apply_decomposition.
+  - SparseLUDecomposition::decompose and SparseLUDecomposition::is_decomposed.
   - The compress() functions without argument in the various vector
     classes. You should use the versions with a VectorOperation
     argument instead.
index ae2b7fe030b3d5e570c1659e8ec5c9464145d2ac..c08f1c8f4d424f22c63c8fd2186e27882063f48f 100644 (file)
@@ -236,24 +236,6 @@ public:
   void initialize (const SparseMatrix<somenumber> &matrix,
                    const AdditionalData parameters);
 
-  /**
-   * This method is deprecated, and left for backward compability. It will be
-   * removed in later versions.
-   *
-   * @deprecated
-   */
-  template <typename somenumber>
-  void decompose (const SparseMatrix<somenumber> &matrix,
-                  const double                    strengthen_diagonal=0.) DEAL_II_DEPRECATED;
-
-  /**
-   * This method is deprecated, and left for backward compability. It will be
-   * removed in later versions.
-   *
-   * @deprecated
-   */
-  virtual bool is_decomposed () const DEAL_II_DEPRECATED;
-
   /**
    * Return whether the object is empty. It calls the inherited
    * SparseMatrix::empty() function.
@@ -324,11 +306,12 @@ protected:
    */
   std::vector<const size_type *> prebuilt_lower_bound;
 
-private:
   /**
    * Fills the #prebuilt_lower_bound array.
    */
   void prebuild_lower_bound ();
+  
+private:
 
   /**
    * In general this pointer is zero except for the case that no
@@ -358,15 +341,6 @@ get_strengthen_diagonal(const number /*rowsum*/,
 
 
 
-template <typename number>
-inline bool
-SparseLUDecomposition<number>::is_decomposed () const
-{
-  return decomposed;
-}
-
-
-
 template <typename number>
 inline bool
 SparseLUDecomposition<number>::empty () const
index cc026005499960f3ae22930ec3ed4d57da7b0488..bcf772404bc163c402a56c23b18654d7a9442e6e 100644 (file)
@@ -131,22 +131,6 @@ void SparseLUDecomposition<number>::initialize (
 }
 
 
-template<typename number>
-template<typename somenumber>
-void
-SparseLUDecomposition<number>::
-decompose (const SparseMatrix<somenumber> &matrix,
-           const double                    strengthen_diagonal)
-{
-  decomposed = false;
-
-  this->strengthen_diagonal = strengthen_diagonal;
-  prebuild_lower_bound ();
-  copy_from (matrix);
-  decomposed = true;
-}
-
-
 
 template<typename number>
 void
index 9c0c1faf33c23e1c54292707e1f09c4d60b2595a..4b6820acf437edca6d54824ef546066d04859286 100644 (file)
@@ -48,7 +48,11 @@ void SparseILU<number>::initialize (const SparseMatrix<somenumber> &matrix,
   Assert (data.strengthen_diagonal>=0,
           ExcInvalidStrengthening (data.strengthen_diagonal));
 
-  SparseLUDecomposition<number>::decompose (matrix, data.strengthen_diagonal);
+  this->decomposed = false;
+  this->strengthen_diagonal = data.strengthen_diagonal;
+  this->prebuild_lower_bound ();
+  this->copy_from (matrix);
+  this->decomposed = true;
 
   if (data.strengthen_diagonal>0)
     this->strengthen_diagonal_impl();
index 5113c2a65dce2a20a1954323813dc3f95cebdca0..ae77a0e9588e1687077293d853b50f44c757429d 100644 (file)
@@ -66,16 +66,20 @@ inline
 void SparseMIC<number>::initialize (const SparseMatrix<somenumber> &matrix,
                                     const AdditionalData &data)
 {
-  SparseLUDecomposition<number>::initialize(matrix, data);
-
-  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 (data.strengthen_diagonal>=0, ExcInvalidStrengthening (data.strengthen_diagonal));
 
+  SparseLUDecomposition<number>::initialize(matrix, data);
+
+  this->decomposed = false;
+  this->strengthen_diagonal = data.strengthen_diagonal;
+  this->prebuild_lower_bound ();
+  this->copy_from (matrix);
+  this->decomposed = true;
+
   if (data.strengthen_diagonal > 0)
     this->strengthen_diagonal_impl ();
 
index ad68d92a16bcccf2d673916ba2c96aadbf030901..256183f574f2110b2545c60927d8d9bb57f3a9c1 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.
 //
@@ -24,10 +24,6 @@ template void SparseLUDecomposition<double>::initialize<double> (const SparseMat
     const AdditionalData data);
 template void SparseLUDecomposition<double>::initialize<float> (const SparseMatrix<float> &,
     const AdditionalData data);
-template void SparseLUDecomposition<double>::decompose<double> (const SparseMatrix<double> &,
-    const double);
-template void SparseLUDecomposition<double>::decompose<float> (const SparseMatrix<float> &,
-    const double);
 
 template void SparseLUDecomposition<double>::copy_from<double> (const SparseMatrix<double> &);
 template void SparseLUDecomposition<double>::copy_from<float> (const SparseMatrix<float> &);
@@ -38,10 +34,6 @@ template void SparseLUDecomposition<float>::initialize<double> (const SparseMatr
     const AdditionalData data);
 template void SparseLUDecomposition<float>::initialize<float> (const SparseMatrix<float> &,
     const AdditionalData data);
-template void SparseLUDecomposition<float>::decompose<double> (const SparseMatrix<double> &,
-    const double);
-template void SparseLUDecomposition<float>::decompose<float> (const SparseMatrix<float> &,
-    const double);
 
 template void SparseLUDecomposition<float>::copy_from<double> (const SparseMatrix<double> &);
 template void SparseLUDecomposition<float>::copy_from<float> (const SparseMatrix<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.