Reference documentation for deal.II version 9.0.0
|
#include <deal.II/lac/petsc_solver.h>
Classes | |
struct | AdditionalData |
Public Member Functions | |
SolverBicgstab (SolverControl &cn, const MPI_Comm &mpi_communicator=PETSC_COMM_SELF, const AdditionalData &data=AdditionalData()) | |
Public Member Functions inherited from PETScWrappers::SolverBase | |
SolverBase (SolverControl &cn, const MPI_Comm &mpi_communicator) | |
virtual | ~SolverBase ()=default |
void | solve (const MatrixBase &A, VectorBase &x, const VectorBase &b, const PreconditionerBase &preconditioner) |
virtual void | reset () |
void | set_prefix (const std::string &prefix) |
SolverControl & | control () const |
void | initialize (const PreconditionerBase &preconditioner) |
Protected Member Functions | |
virtual void | set_solver_type (KSP &ksp) const |
Protected Attributes | |
const AdditionalData | additional_data |
Protected Attributes inherited from PETScWrappers::SolverBase | |
SolverControl & | solver_control |
const MPI_Comm | mpi_communicator |
std::string | prefix_name |
An implementation of the solver interface using the PETSc BiCGStab solver.
Definition at line 543 of file petsc_solver.h.
SolverBicgstab< VectorType >::SolverBicgstab | ( | SolverControl & | cn, |
const MPI_Comm & | mpi_communicator = PETSC_COMM_SELF , |
||
const AdditionalData & | data = AdditionalData() |
||
) |
Constructor. In contrast to deal.II's own solvers, there is no need to give a vector memory object. However, PETSc solvers want to have an MPI communicator context over which computations are parallelized. By default, PETSC_COMM_SELF
is used here, but you can change this. Note that for single processor (non-MPI) versions, this parameter does not have any effect.
The last argument takes a structure with additional, solver dependent flags for tuning.
Note that the communicator used here must match the communicator used in the system matrix, solution, and right hand side object of the solve to be done with this solver. Otherwise, PETSc will generate hard to track down errors, see the documentation of the SolverBase class.
Definition at line 441 of file petsc_solver.cc.
|
protectedvirtual |
Function that takes a Krylov Subspace Solver context object, and sets the type of solver that is appropriate for this class.
Implements PETScWrappers::SolverBase.
Definition at line 451 of file petsc_solver.cc.
|
protected |
Store a copy of the flags for this particular solver.
Definition at line 576 of file petsc_solver.h.