/**
* Constructor.
*/
- explicit PreconditionBase(const MPI_Comm &mpi_communicator = MPI_COMM_NULL);
+ explicit PreconditionBase(const MPI_Comm &mpi_communicator);
+
+ /**
+ * Constructor. This constructor is deprecated.
+ *
+ * @deprecated
+ */
+ DEAL_II_DEPRECATED
+ PreconditionBase();
/**
* Destructor.
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionJacobi() = default;
+ PreconditionJacobi();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionBlockJacobi() = default;
+ PreconditionBlockJacobi();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionSOR() = default;
+ PreconditionSOR();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionSSOR() = default;
+ PreconditionSSOR();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionICC() = default;
+ PreconditionICC();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionILU() = default;
+ PreconditionILU();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionLU() = default;
+ PreconditionLU();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionBoomerAMG() = default;
+ PreconditionBoomerAMG();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionParaSails() = default;
+ PreconditionParaSails();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionNone() = default;
+ PreconditionNone();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
* Empty Constructor. You need to call initialize() before using this
* object.
*/
- PreconditionBDDC() = default;
+ PreconditionBDDC();
/**
* Constructor. Take the matrix which is used to form the preconditioner,
+ PreconditionBase::PreconditionBase()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionBase::~PreconditionBase()
{
try
/* ----------------- PreconditionJacobi -------------------- */
+
+ PreconditionJacobi::PreconditionJacobi()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionJacobi::PreconditionJacobi(const MPI_Comm & comm,
const AdditionalData &additional_data_)
: PreconditionBase(comm)
/* ----------------- PreconditionBlockJacobi -------------------- */
+ PreconditionBlockJacobi::PreconditionBlockJacobi()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
PreconditionBlockJacobi::PreconditionBlockJacobi(
const MPI_Comm & comm,
/* ----------------- PreconditionSOR -------------------- */
+ PreconditionSOR::PreconditionSOR()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionSOR::AdditionalData::AdditionalData(const double omega)
: omega(omega)
{}
/* ----------------- PreconditionSSOR -------------------- */
+ PreconditionSSOR::PreconditionSSOR()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionSSOR::AdditionalData::AdditionalData(const double omega)
: omega(omega)
{}
/* ----------------- PreconditionICC -------------------- */
+ PreconditionICC::PreconditionICC()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
PreconditionICC::AdditionalData::AdditionalData(const unsigned int levels)
: levels(levels)
/* ----------------- PreconditionILU -------------------- */
+ PreconditionILU::PreconditionILU()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionILU::AdditionalData::AdditionalData(const unsigned int levels)
: levels(levels)
{}
} // namespace
# endif
+
+
+ PreconditionBoomerAMG::PreconditionBoomerAMG()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionBoomerAMG::PreconditionBoomerAMG(
const MPI_Comm & comm,
const AdditionalData &additional_data_)
+ PreconditionParaSails::PreconditionParaSails()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionParaSails::PreconditionParaSails(
const MatrixBase & matrix,
const AdditionalData &additional_data)
/* ----------------- PreconditionNone ------------------------- */
+ PreconditionNone::PreconditionNone()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionNone::PreconditionNone(const MatrixBase & matrix,
const AdditionalData &additional_data)
: PreconditionBase(matrix.get_mpi_communicator())
+ PreconditionLU::PreconditionLU()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
PreconditionLU::PreconditionLU(const MatrixBase & matrix,
const AdditionalData &additional_data)
: PreconditionBase(matrix.get_mpi_communicator())
+ template <int dim>
+ PreconditionBDDC<dim>::PreconditionBDDC()
+ : PreconditionBase(MPI_COMM_NULL)
+ {}
+
+
+
template <int dim>
PreconditionBDDC<dim>::PreconditionBDDC(
const MPI_Comm comm,