![]() |
Reference documentation for deal.II version 9.1.1
|
#include <deal.II/lac/solver_richardson.h>
Classes | |
struct | AdditionalData |
Public Member Functions | |
SolverRichardson (SolverControl &cn, VectorMemory< VectorType > &mem, const AdditionalData &data=AdditionalData()) | |
SolverRichardson (SolverControl &cn, const AdditionalData &data=AdditionalData()) | |
virtual | ~SolverRichardson () override=default |
template<typename MatrixType , typename PreconditionerType > | |
void | solve (const MatrixType &A, VectorType &x, const VectorType &b, const PreconditionerType &preconditioner) |
template<typename MatrixType , typename PreconditionerType > | |
void | Tsolve (const MatrixType &A, VectorType &x, const VectorType &b, const PreconditionerType &preconditioner) |
void | set_omega (const double om=1.) |
virtual void | print_vectors (const unsigned int step, const VectorType &x, const VectorType &r, const VectorType &d) const |
![]() | |
SolverBase (SolverControl &solver_control, VectorMemory< VectorType > &vector_memory) | |
SolverBase (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) |
![]() | |
Subscriptor () | |
Subscriptor (const Subscriptor &) | |
Subscriptor (Subscriptor &&) noexcept | |
virtual | ~Subscriptor () |
Subscriptor & | operator= (const Subscriptor &) |
Subscriptor & | operator= (Subscriptor &&) noexcept |
void | subscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
void | unsubscribe (std::atomic< bool > *const validity, const std::string &identifier="") const |
unsigned int | n_subscriptions () const |
template<typename StreamType > | |
void | list_subscribers (StreamType &stream) const |
void | list_subscribers () const |
template<class Archive > | |
void | serialize (Archive &ar, const unsigned int version) |
Protected Member Functions | |
virtual VectorType::value_type | criterion (const VectorType &r, const VectorType &d) const |
Protected Attributes | |
AdditionalData | additional_data |
![]() | |
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 | |
![]() | |
using | vector_type = VectorType |
![]() | |
static ::ExceptionBase & | ExcInUse (int arg1, std::string arg2, std::string arg3) |
static ::ExceptionBase & | ExcNoSubscriber (std::string arg1, std::string arg2) |
Implementation of the preconditioned Richardson iteration method. The stopping criterion is the norm of the residual.
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.
For the Richardson method, the additional data is the damping parameter, which is the only content of the AdditionalData
structure. By default, the constructor of the structure sets it to one.
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 63 of file solver_richardson.h.
SolverRichardson< VectorType >::SolverRichardson | ( | SolverControl & | cn, |
VectorMemory< VectorType > & | mem, | ||
const AdditionalData & | data = AdditionalData() |
||
) |
Constructor.
SolverRichardson< VectorType >::SolverRichardson | ( | SolverControl & | cn, |
const AdditionalData & | data = AdditionalData() |
||
) |
Constructor. Use an object of type GrowingVectorMemory as a default to allocate memory.
|
overridevirtualdefault |
Virtual destructor.
void SolverRichardson< VectorType >::solve | ( | const MatrixType & | A, |
VectorType & | x, | ||
const VectorType & | b, | ||
const PreconditionerType & | preconditioner | ||
) |
Solve the linear system Ax=b for x.
void SolverRichardson< VectorType >::Tsolve | ( | const MatrixType & | A, |
VectorType & | x, | ||
const VectorType & | b, | ||
const PreconditionerType & | preconditioner | ||
) |
Solve A^Tx=b for x.
void SolverRichardson< VectorType >::set_omega | ( | const double | om = 1. | ) |
Set the damping-coefficient. Default is 1., i.e. no damping.
|
virtual |
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.
|
protectedvirtual |
Implementation of the computation of the norm of the residual. Depending on the flags given to the solver, the default implementation of this function uses either the actual residual, r
, or the preconditioned residual, d
.
|
protected |
Control parameters.
Definition at line 157 of file solver_richardson.h.