Reference documentation for deal.II version 8.5.1
|
#include <deal.II/lac/trilinos_precondition.h>
Classes | |
struct | AdditionalData |
Public Types | |
typedef ::types::global_dof_index | size_type |
Public Member Functions | |
PreconditionBase () | |
PreconditionBase (const PreconditionBase &) | |
~PreconditionBase () | |
void | clear () |
MPI_Comm | get_mpi_communicator () const |
void | transpose () |
virtual void | vmult (VectorBase &dst, const VectorBase &src) const |
virtual void | Tvmult (VectorBase &dst, const VectorBase &src) const |
virtual void | vmult (::Vector< double > &dst, const ::Vector< double > &src) const |
virtual void | Tvmult (::Vector< double > &dst, const ::Vector< double > &src) const |
virtual void | vmult (::LinearAlgebra::distributed::Vector< double > &dst, const ::LinearAlgebra::distributed::Vector< double > &src) const |
virtual void | Tvmult (::LinearAlgebra::distributed::Vector< double > &dst, const ::LinearAlgebra::distributed::Vector< double > &src) const |
Access to underlying Trilinos data | |
Epetra_Operator & | trilinos_operator () const |
Partitioners | |
IndexSet | locally_owned_domain_indices () const |
IndexSet | locally_owned_range_indices () const |
Public Member Functions inherited from Subscriptor | |
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) |
Static Public Member Functions | |
static ::ExceptionBase & | ExcNonMatchingMaps (std::string arg1) |
Static Public Member Functions inherited from Subscriptor | |
static ::ExceptionBase & | ExcInUse (int arg1, char *arg2, std::string &arg3) |
static ::ExceptionBase & | ExcNoSubscriber (char *arg1, char *arg2) |
Protected Attributes | |
std_cxx11::shared_ptr< Epetra_Operator > | preconditioner |
Epetra_MpiComm | communicator |
std_cxx11::shared_ptr< Epetra_Map > | vector_distributor |
The base class for all preconditioners based on Trilinos sparse matrices.
Definition at line 78 of file trilinos_precondition.h.
Declare the type for container size.
Definition at line 84 of file trilinos_precondition.h.
TrilinosWrappers::PreconditionBase::PreconditionBase | ( | ) |
Constructor. Does not do anything. The initialize
function of the derived classes will have to create the preconditioner from a given sparse matrix.
Definition at line 37 of file trilinos_precondition.cc.
TrilinosWrappers::PreconditionBase::PreconditionBase | ( | const PreconditionBase & | base | ) |
Copy constructor.
Definition at line 46 of file trilinos_precondition.cc.
TrilinosWrappers::PreconditionBase::~PreconditionBase | ( | ) |
Destructor.
Definition at line 58 of file trilinos_precondition.cc.
void TrilinosWrappers::PreconditionBase::clear | ( | ) |
Destroys the preconditioner, leaving an object like just after having called the constructor.
Definition at line 63 of file trilinos_precondition.cc.
MPI_Comm TrilinosWrappers::PreconditionBase::get_mpi_communicator | ( | ) | const |
Return the MPI communicator object in use with this matrix.
Definition at line 74 of file trilinos_precondition.cc.
void TrilinosWrappers::PreconditionBase::transpose | ( | ) |
Sets an internal flag so that all operations performed by the matrix, i.e., multiplications, are done in transposed order. However, this does not reshape the matrix to transposed form directly, so care should be taken when using this flag.
|
virtual |
Apply the preconditioner.
Reimplemented in TrilinosWrappers::PreconditionIdentity.
|
virtual |
Apply the transpose preconditioner.
Reimplemented in TrilinosWrappers::PreconditionIdentity.
|
virtual |
Apply the preconditioner on deal.II data structures instead of the ones provided in the Trilinos wrapper class.
Reimplemented in TrilinosWrappers::PreconditionIdentity.
|
virtual |
Apply the transpose preconditioner on deal.II data structures instead of the ones provided in the Trilinos wrapper class.
Reimplemented in TrilinosWrappers::PreconditionIdentity.
|
virtual |
Apply the preconditioner on deal.II parallel data structures instead of the ones provided in the Trilinos wrapper class.
|
virtual |
Apply the transpose preconditioner on deal.II parallel data structures instead of the ones provided in the Trilinos wrapper class.
Epetra_Operator & TrilinosWrappers::PreconditionBase::trilinos_operator | ( | ) | const |
Calling this function from an uninitialized object will cause an exception.
Definition at line 85 of file trilinos_precondition.cc.
IndexSet TrilinosWrappers::PreconditionBase::locally_owned_domain_indices | ( | ) | const |
Return the partitioning of the domain space of this matrix, i.e., the partitioning of the vectors this matrix has to be multiplied with.
Definition at line 93 of file trilinos_precondition.cc.
IndexSet TrilinosWrappers::PreconditionBase::locally_owned_range_indices | ( | ) | const |
Return the partitioning of the range space of this matrix, i.e., the partitioning of the vectors that are result from matrix-vector products.
Definition at line 100 of file trilinos_precondition.cc.
|
protected |
This is a pointer to the preconditioner object that is used when applying the preconditioner.
Definition at line 227 of file trilinos_precondition.h.
|
protected |
Internal communication pattern in case the matrix needs to be copied from deal.II format.
Definition at line 234 of file trilinos_precondition.h.
|
protected |
Internal Trilinos map in case the matrix needs to be copied from deal.II format.
Definition at line 243 of file trilinos_precondition.h.