- 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.
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.
*/
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
-template <typename number>
-inline bool
-SparseLUDecomposition<number>::is_decomposed () const
-{
- return decomposed;
-}
-
-
-
template <typename number>
inline bool
SparseLUDecomposition<number>::empty () const
}
-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
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();
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 ();
// ---------------------------------------------------------------------
//
-// 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.
//
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> &);
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> &);