![]() |
Reference documentation for deal.II version 8.5.1
|
#include <deal.II/lac/relaxation_block.h>
Public Types | |
typedef MatrixType::value_type | number |
Public Member Functions | |
void | step (VectorType &dst, const VectorType &rhs) const |
void | Tstep (VectorType &dst, const VectorType &rhs) const |
std::size_t | memory_consumption () const |
![]() | |
Subscriptor () | |
Subscriptor (const Subscriptor &) | |
Subscriptor (Subscriptor &&) | |
virtual | ~Subscriptor () |
Subscriptor & | operator= (const Subscriptor &) |
Subscriptor & | operator= (Subscriptor &&) |
void | subscribe (const char *identifier=0) const |
void | unsubscribe (const char *identifier=0) const |
unsigned int | n_subscriptions () const |
void | list_subscribers () const |
template<class Archive > | |
void | serialize (Archive &ar, const unsigned int version) |
Additional Inherited Members | |
![]() | |
static ::ExceptionBase & | ExcInUse (int arg1, char *arg2, std::string &arg3) |
static ::ExceptionBase & | ExcNoSubscriber (char *arg1, char *arg2) |
![]() | |
typedef types::global_dof_index | size_type |
![]() | |
enum | Inversion |
typedef types::global_dof_index | size_type |
![]() | |
void | do_step (VectorType &dst, const VectorType &prev, const VectorType &src, const bool backward) const |
void | initialize (const MatrixType &A, const AdditionalData ¶meters) |
void | clear () |
bool | empty () const |
value_type | el (size_type i, size_type j) const |
void | invert_diagblocks () |
![]() | |
PreconditionBlockBase (bool store_diagonals=false, Inversion method=gauss_jordan) | |
~PreconditionBlockBase () | |
void | clear () |
void | reinit (unsigned int nblocks, size_type blocksize, bool compress, Inversion method=gauss_jordan) |
void | inverses_computed (bool are_they) |
void | set_same_diagonal () |
bool | same_diagonal () const |
bool | store_diagonals () const |
bool | inverses_ready () const |
bool | empty () const |
unsigned int | size () const |
InverseNumberType | el (size_type i, size_type j) const |
void | inverse_vmult (size_type i, Vector< number2 > &dst, const Vector< number2 > &src) const |
void | inverse_Tvmult (size_type i, Vector< number2 > &dst, const Vector< number2 > &src) const |
FullMatrix< InverseNumberType > & | inverse (size_type i) |
const FullMatrix< InverseNumberType > & | inverse (size_type i) const |
Householder< InverseNumberType > & | inverse_householder (size_type i) |
const Householder< InverseNumberType > & | inverse_householder (size_type i) const |
LAPACKFullMatrix< InverseNumberType > & | inverse_svd (size_type i) |
const LAPACKFullMatrix< InverseNumberType > & | inverse_svd (size_type i) const |
FullMatrix< InverseNumberType > & | diagonal (size_type i) |
const FullMatrix< InverseNumberType > & | diagonal (size_type i) const |
void | log_statistics () const |
std::size_t | memory_consumption () const |
![]() | |
static ::ExceptionBase & | ExcDiagonalsNotStored () |
static ::ExceptionBase & | ExcInverseNotAvailable () |
![]() | |
SmartPointer< const MatrixType, RelaxationBlock< MatrixType, InverseNumberType, VectorType > > | A |
SmartPointer< const AdditionalData, RelaxationBlock< MatrixType, InverseNumberType, VectorType > > | additional_data |
![]() | |
Inversion | inversion |
Block Jacobi (additive Schwarz) method with possibly overlapping blocks.
This class implements the step() and Tstep() functions expected by the relaxation concept. They perform an additive Schwarz method on the blocks provided in the block list of AdditionalData. Differing from PreconditionBlockJacobi, these blocks may be of varying size, non- contiguous, and overlapping. On the other hand, this class does not implement the preconditioner interface expected by Solver objects.
Definition at line 279 of file relaxation_block.h.
typedef MatrixType::value_type RelaxationBlockJacobi< MatrixType, InverseNumberType, VectorType >::number |
Default constructor. Define number type of matrix.
Definition at line 291 of file relaxation_block.h.
void RelaxationBlockJacobi< MatrixType, InverseNumberType, VectorType >::step | ( | VectorType & | dst, |
const VectorType & | rhs | ||
) | const |
Perform one step of the Jacobi iteration.
void RelaxationBlockJacobi< MatrixType, InverseNumberType, VectorType >::Tstep | ( | VectorType & | dst, |
const VectorType & | rhs | ||
) | const |
Perform one step of the Jacobi iteration.
std::size_t RelaxationBlockJacobi< MatrixType, InverseNumberType, VectorType >::memory_consumption | ( | ) | const |
Return the memory allocated in this object.