Reference documentation for deal.II version 9.0.0
|
#include <deal.II/lac/solver_minres.h>
Classes | |
struct | AdditionalData |
Public Member Functions | |
SolverMinRes (SolverControl &cn, VectorMemory< VectorType > &mem, const AdditionalData &data=AdditionalData()) | |
SolverMinRes (SolverControl &cn, const AdditionalData &data=AdditionalData()) | |
virtual | ~SolverMinRes ()=default |
template<typename MatrixType , typename PreconditionerType > | |
void | solve (const MatrixType &A, VectorType &x, const VectorType &b, const PreconditionerType &preconditioner) |
Public Member Functions inherited from Solver< VectorType > | |
Solver (SolverControl &solver_control, VectorMemory< VectorType > &vector_memory) | |
Solver (SolverControl &solver_control) | |
boost::signals2::connection | connect (const std::function< SolverControl::State(const unsigned int iteration, const double check_value, const VectorType ¤t_iterate)> &slot) |
Public Member Functions inherited from Subscriptor | |
Subscriptor () | |
Subscriptor (const Subscriptor &) | |
Subscriptor (Subscriptor &&) noexcept | |
virtual | ~Subscriptor () |
Subscriptor & | operator= (const Subscriptor &) |
Subscriptor & | operator= (Subscriptor &&) noexcept |
void | subscribe (const char *identifier=nullptr) const |
void | unsubscribe (const char *identifier=nullptr) const |
unsigned int | n_subscriptions () const |
void | list_subscribers () const |
template<class Archive > | |
void | serialize (Archive &ar, const unsigned int version) |
Static Public Member Functions | |
static ::ExceptionBase & | ExcPreconditionerNotDefinite () |
Static Public Member Functions inherited from Subscriptor | |
static ::ExceptionBase & | ExcInUse (int arg1, std::string arg2, std::string arg3) |
static ::ExceptionBase & | ExcNoSubscriber (std::string arg1, std::string arg2) |
Protected Member Functions | |
virtual double | criterion () |
virtual void | print_vectors (const unsigned int step, const VectorType &x, const VectorType &r, const VectorType &d) const |
Protected Attributes | |
double | res2 |
Protected Attributes inherited from Solver< VectorType > | |
GrowingVectorMemory< VectorType > | static_vector_memory |
VectorMemory< VectorType > & | memory |
boost::signals2::signal< SolverControl::State(const unsigned int iteration, const double check_value, const VectorType ¤t_iterate), StateCombiner > | iteration_status |
Additional Inherited Members | |
Public Types inherited from Solver< VectorType > | |
typedef VectorType | vector_type |
Minimal residual method for symmetric matrices.
For the requirements on matrices and vectors in order to work with this class, see the documentation of the Solver base class.
Like all other solver classes, this class has a local structure called AdditionalData
which is used to pass additional parameters to the solver, like damping parameters or the number of temporary vectors. We use this additional structure instead of passing these values directly to the constructor because this makes the use of the SolverSelector
and other classes much easier and guarantees that these will continue to work even if number or type of the additional parameters for a certain solver changes.
However, since the MinRes method does not need additional data, the respective structure is empty and does not offer any functionality. The constructor has a default argument, so you may call it without the additional parameter.
The preconditioner has to be positive definite and symmetric
The algorithm is taken from the Master thesis of Astrid Battermann with some changes. The full text can be found at http://scholar.lib.vt.edu/theses/public/etd-12164379662151/etd-title.html
The solve() function of this class uses the mechanism described in the Solver base class to determine convergence. This mechanism can also be used to observe the progress of the iteration.
Definition at line 69 of file solver_minres.h.
SolverMinRes< VectorType >::SolverMinRes | ( | SolverControl & | cn, |
VectorMemory< VectorType > & | mem, | ||
const AdditionalData & | data = AdditionalData() |
||
) |
Constructor.
SolverMinRes< VectorType >::SolverMinRes | ( | SolverControl & | cn, |
const AdditionalData & | data = AdditionalData() |
||
) |
Constructor. Use an object of type GrowingVectorMemory as a default to allocate memory.
|
virtualdefault |
Virtual destructor.
void SolverMinRes< VectorType >::solve | ( | const MatrixType & | A, |
VectorType & | x, | ||
const VectorType & | b, | ||
const PreconditionerType & | preconditioner | ||
) |
Solve the linear system \(Ax=b\) for x.
|
protectedvirtual |
Implementation of the computation of the norm of the residual.
|
protectedvirtual |
Interface for derived class. This function gets the current iteration vector, the residual and the update vector in each step. It can be used for graphical output of the convergence history.
|
protected |
Within the iteration loop, the square of the residual vector is stored in this variable. The function criterion
uses this variable to compute the convergence value, which in this class is the norm of the residual vector and thus the square root of the res2
value.
Definition at line 142 of file solver_minres.h.