deal.II version GIT relicensing-2167-g9622207b8f 2024-11-21 12:40:00+00:00
|
#include <deal.II/lac/trilinos_solver.h>
Classes | |
struct | AdditionalData |
Public Member Functions | |
SolverDirect (const AdditionalData &data=AdditionalData()) | |
SolverDirect (SolverControl &cn, const AdditionalData &data=AdditionalData()) | |
virtual | ~SolverDirect ()=default |
void | initialize (const SparseMatrix &A) |
void | initialize (const SparseMatrix &A, const AdditionalData &data) |
void | solve (MPI::Vector &x, const MPI::Vector &b) |
void | solve (::LinearAlgebra::distributed::Vector< double > &x, const ::LinearAlgebra::distributed::Vector< double > &b) |
void | vmult (MPI::Vector &x, const MPI::Vector &b) const |
void | vmult (::LinearAlgebra::distributed::Vector< double > &x, const ::LinearAlgebra::distributed::Vector< double > &b) const |
void | solve (const SparseMatrix &A, MPI::Vector &x, const MPI::Vector &b) |
void | solve (const SparseMatrix &A, ::Vector< double > &x, const ::Vector< double > &b) |
void | solve (const SparseMatrix &A, ::LinearAlgebra::distributed::Vector< double > &x, const ::LinearAlgebra::distributed::Vector< double > &b) |
SolverControl & | control () const |
template<class Archive > | |
void | serialize (Archive &ar, const unsigned int version) |
EnableObserverPointer functionality | |
Classes derived from EnableObserverPointer provide a facility to subscribe to this object. This is mostly used by the ObserverPointer class. | |
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 |
Static Public Member Functions | |
static ::ExceptionBase & | ExcTrilinosError (int arg1) |
static ::ExceptionBase & | ExcInUse (int arg1, std::string arg2, std::string arg3) |
static ::ExceptionBase & | ExcNoSubscriber (std::string arg1, std::string arg2) |
Private Types | |
using | map_value_type = decltype(counter_map)::value_type |
using | map_iterator = decltype(counter_map)::iterator |
Private Member Functions | |
void | do_solve () |
void | check_no_subscribers () const noexcept |
Private Attributes | |
SolverControl | solver_control_own |
SolverControl & | solver_control |
std::unique_ptr< Epetra_LinearProblem > | linear_problem |
std::unique_ptr< Amesos_BaseSolver > | solver |
AdditionalData | additional_data |
std::atomic< unsigned int > | counter |
std::map< std::string, unsigned int > | counter_map |
std::vector< std::atomic< bool > * > | validity_pointers |
const std::type_info * | object_info |
Static Private Attributes | |
static std::mutex | mutex |
An implementation of Trilinos direct solvers (using the Amesos package). The data field AdditionalData::solver_type can be used to specify the type of solver. It allows the use of built-in solvers Amesos_Klu as well as third-party solvers Amesos_Superludist or Amesos_Mumps.
For instructions on how to install Trilinos for use with direct solvers other than KLU, see the link to the Trilinos installation instructions linked to from the deal.II ReadMe file.
Definition at line 485 of file trilinos_solver.h.
|
privateinherited |
The data type used in counter_map.
Definition at line 238 of file enable_observer_pointer.h.
|
privateinherited |
The iterator type used in counter_map.
Definition at line 243 of file enable_observer_pointer.h.
|
explicit |
Constructor. Creates the solver without solver control object.
Definition at line 639 of file trilinos_solver.cc.
TrilinosWrappers::SolverDirect::SolverDirect | ( | SolverControl & | cn, |
const AdditionalData & | data = AdditionalData() |
||
) |
Constructor. Takes the solver control object and creates the solver.
Definition at line 646 of file trilinos_solver.cc.
|
virtualdefault |
Destructor.
void TrilinosWrappers::SolverDirect::initialize | ( | const SparseMatrix & | A | ) |
Initializes the direct solver for the matrix A
and creates a factorization for it with the package chosen from the additional data structure. Note that there is no need for a preconditioner here and solve() is not called.
Definition at line 662 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::initialize | ( | const SparseMatrix & | A, |
const AdditionalData & | data | ||
) |
Initializes the direct solver for the matrix A
and creates a factorization for it with the package chosen from the additional data structure. Note that there is no need for a preconditioner here and solve() is not called. Furthermore, data
replaces the data stored in this instance.
Definition at line 708 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::solve | ( | MPI::Vector & | x, |
const MPI::Vector & | b | ||
) |
Solve the linear system Ax=b
based on the package set in the constructor on initialize(). Note the matrix is not refactored during this call.
Definition at line 717 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::solve | ( | ::LinearAlgebra::distributed::Vector< double > & | x, |
const ::LinearAlgebra::distributed::Vector< double > & | b | ||
) |
Solve the linear system Ax=b
based on the package set in initialize() for deal.II's own parallel vectors. Note the matrix is not refactored during this call.
Definition at line 725 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::vmult | ( | MPI::Vector & | x, |
const MPI::Vector & | b | ||
) | const |
Solve the linear system Ax=b
based on the package set in the constructor or initialize(). Note the matrix is not refactored during this call.
Definition at line 734 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::vmult | ( | ::LinearAlgebra::distributed::Vector< double > & | x, |
const ::LinearAlgebra::distributed::Vector< double > & | b | ||
) | const |
Solve the linear system Ax=b
based on the package set in initialize() for deal.II's own parallel vectors. Note the matrix is not refactored during this call.
Definition at line 762 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::solve | ( | const SparseMatrix & | A, |
MPI::Vector & | x, | ||
const MPI::Vector & | b | ||
) |
Solve the linear system Ax=b
. Creates a factorization of the matrix with the package chosen from the additional data structure and performs the solve. Note that there is no need for a preconditioner here.
Definition at line 848 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::solve | ( | const SparseMatrix & | A, |
::Vector< double > & | x, | ||
const ::Vector< double > & | b | ||
) |
Solve the linear system Ax=b
. This class works with Trilinos matrices, but takes deal.II serial vectors as argument. Since these vectors are not distributed, this function does only what you expect in case the matrix is serial (i.e., locally owned). Otherwise, an exception will be thrown.
Definition at line 865 of file trilinos_solver.cc.
void TrilinosWrappers::SolverDirect::solve | ( | const SparseMatrix & | A, |
::LinearAlgebra::distributed::Vector< double > & | x, | ||
const ::LinearAlgebra::distributed::Vector< double > & | b | ||
) |
Solve the linear system Ax=b
for deal.II's own parallel vectors. Creates a factorization of the matrix with the package chosen from the additional data structure and performs the solve. Note that there is no need for a preconditioner here.
SolverControl & TrilinosWrappers::SolverDirect::control | ( | ) | const |
Access to object that controls convergence.
Definition at line 654 of file trilinos_solver.cc.
|
private |
Actually performs the operations for solving the linear system, including the factorization and forward and backward substitution.
Definition at line 797 of file trilinos_solver.cc.
|
inherited |
Subscribes a user of the object by storing the pointer validity
. The subscriber may be identified by text supplied as identifier
.
Definition at line 131 of file enable_observer_pointer.cc.
|
inherited |
Unsubscribes a user from the object.
identifier
and the validity
pointer must be the same as the one supplied to subscribe(). Definition at line 151 of file enable_observer_pointer.cc.
|
inlineinherited |
Return the present number of subscriptions to this object. This allows to use this class for reference counted lifetime determination where the last one to unsubscribe also deletes the object.
Definition at line 322 of file enable_observer_pointer.h.
|
inlineinherited |
List the subscribers to the input stream
.
Definition at line 339 of file enable_observer_pointer.h.
|
inherited |
List the subscribers to deallog
.
Definition at line 199 of file enable_observer_pointer.cc.
|
inlineinherited |
Read or write the data of this object to or from a stream for the purpose of serialization using the BOOST serialization library.
This function does not actually serialize any of the member variables of this class. The reason is that what this class stores is only who subscribes to this object, but who does so at the time of storing the contents of this object does not necessarily have anything to do with who subscribes to the object when it is restored. Consequently, we do not want to overwrite the subscribers at the time of restoring, and then there is no reason to write the subscribers out in the first place.
Definition at line 331 of file enable_observer_pointer.h.
|
privatenoexceptinherited |
Check that there are no objects subscribing to this object. If this check passes then it is safe to destroy the current object. It this check fails then this function will either abort or print an error message to deallog (by using the AssertNothrow mechanism), but will not throw an exception.
Definition at line 53 of file enable_observer_pointer.cc.
|
private |
Local dummy solver control object.
Definition at line 653 of file trilinos_solver.h.
|
private |
Reference to the object that controls convergence of the iterative solver. In fact, for these Trilinos wrappers, Trilinos does so itself, but we copy the data from this object before starting the solution process, and copy the data back into it afterwards.
Definition at line 661 of file trilinos_solver.h.
|
private |
A structure that collects the Trilinos sparse matrix, the right hand side vector and the solution vector, which is passed down to the Trilinos solver.
Definition at line 668 of file trilinos_solver.h.
|
private |
A structure that contains the Trilinos solver and preconditioner objects.
Definition at line 674 of file trilinos_solver.h.
|
private |
Store a copy of the flags for this particular solver.
Definition at line 679 of file trilinos_solver.h.
|
mutableprivateinherited |
Store the number of objects which subscribed to this object. Initially, this number is zero, and upon destruction it shall be zero again (i.e. all objects which subscribed should have unsubscribed again).
The creator (and owner) of an object is counted in the map below if HE manages to supply identification.
We use the mutable
keyword in order to allow subscription to constant objects also.
This counter may be read from and written to concurrently in multithreaded code: hence we use the std::atomic
class template.
Definition at line 227 of file enable_observer_pointer.h.
|
mutableprivateinherited |
In this map, we count subscriptions for each different identification string supplied to subscribe().
Definition at line 233 of file enable_observer_pointer.h.
|
mutableprivateinherited |
In this vector, we store pointers to the validity bool in the ObserverPointer objects that subscribe to this class.
Definition at line 249 of file enable_observer_pointer.h.
|
mutableprivateinherited |
Pointer to the typeinfo object of this object, from which we can later deduce the class name. Since this information on the derived class is neither available in the destructor, nor in the constructor, we obtain it in between and store it here.
Definition at line 257 of file enable_observer_pointer.h.
|
staticprivateinherited |
A mutex used to ensure data consistency when accessing the mutable
members of this class. This lock is used in the subscribe() and unsubscribe() functions, as well as in list_subscribers()
.
Definition at line 280 of file enable_observer_pointer.h.