Reference documentation for deal.II version 9.1.1
|
#include <deal.II/lac/solver_relaxation.h>
Classes | |
struct | AdditionalData |
Public Member Functions | |
SolverRelaxation (SolverControl &cn, const AdditionalData &data=AdditionalData()) | |
virtual | ~SolverRelaxation () |
template<typename MatrixType , class RelaxationType > | |
void | solve (const MatrixType &A, VectorType &x, const VectorType &b, const RelaxationType &R) |
Public Member Functions inherited from SolverBase< VectorType > | |
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) |
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 (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) |
Additional Inherited Members | |
Public Types inherited from SolverBase< VectorType > | |
using | vector_type = VectorType |
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 Attributes inherited from SolverBase< 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 |
Implementation of an iterative solver based on relaxation methods. 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. AdditionalData of this class currently does not contain any data.
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 59 of file solver_relaxation.h.
SolverRelaxation< VectorType >::SolverRelaxation | ( | SolverControl & | cn, |
const AdditionalData & | data = AdditionalData() |
||
) |
Constructor.
Definition at line 96 of file solver_relaxation.h.
|
virtual |
Virtual destructor.
Definition at line 104 of file solver_relaxation.h.
void SolverRelaxation< VectorType >::solve | ( | const MatrixType & | A, |
VectorType & | x, | ||
const VectorType & | b, | ||
const RelaxationType & | R | ||
) |
Solve the system \(Ax = b\) using the relaxation method \(x_{k+1} = R(x_k,b)\). The matrix A itself is only used to compute the residual.
Definition at line 111 of file solver_relaxation.h.