|
IBAMR
IBAMR version 0.19.
|
Class PETScLevelSolver is an abstract LinearSolver for solving systems of linear equations on a single SAMRAI::hier::PatchLevel using PETSc. More...
#include <ibtk/PETScLevelSolver.h>

Public Member Functions | |
| PETScLevelSolver () | |
| Default constructor. More... | |
| ~PETScLevelSolver () | |
| Destructor. More... | |
| void | setKSPType (const std::string &ksp_type) |
| Set the KSP type. More... | |
| void | setOptionsPrefix (const std::string &options_prefix) |
| Set the options prefix used by this PETSc solver object. More... | |
| const KSP & | getPETScKSP () const |
| Get the PETSc KSP object. More... | |
| void | getASMSubdomains (std::vector< IS > **nonoverlapping_subdomains, std::vector< IS > **overlapping_subdomains) |
| Get ASM subdomains. More... | |
Functions to access solver parameters. | |
| virtual void | setMaxIterations (int max_iterations) |
| Set the maximum number of nonlinear iterations to use per solve. More... | |
| virtual int | getMaxIterations () const |
| Get the maximum number of nonlinear iterations to use per solve. More... | |
| virtual void | setAbsoluteTolerance (double abs_residual_tol) |
| Set the absolute residual tolerance for convergence. More... | |
| virtual double | getAbsoluteTolerance () const |
| Get the absolute residual tolerance for convergence. More... | |
| virtual void | setRelativeTolerance (double rel_residual_tol) |
| Set the relative residual tolerance for convergence. More... | |
| virtual double | getRelativeTolerance () const |
| Get the relative residual tolerance for convergence. More... | |
Logging functions. | |
| std::string | d_object_name = "unitialized" |
| bool | d_is_initialized = false |
| bool | d_homogeneous_bc = false |
| double | d_solution_time = std::numeric_limits<double>::quiet_NaN() |
| double | d_current_time = std::numeric_limits<double>::quiet_NaN() |
| double | d_new_time = std::numeric_limits<double>::quiet_NaN() |
| double | d_rel_residual_tol = 0.0 |
| double | d_abs_residual_tol = 0.0 |
| int | d_max_iterations = 100 |
| int | d_current_iterations = 0 |
| double | d_current_residual_norm = std::numeric_limits<double>::quiet_NaN() |
| SAMRAI::tbox::Pointer< HierarchyMathOps > | d_hier_math_ops |
| bool | d_hier_math_ops_external = false |
| bool | d_enable_logging = false |
| virtual void | setLoggingEnabled (bool enable_logging=true) |
| Enable or disable logging. More... | |
| virtual bool | getLoggingEnabled () const |
| Determine whether logging is enabled or disabled. More... | |
| void | init (const std::string &object_name, bool homogeneous_bc) |
| virtual void | initSpecialized (const std::string &object_name, bool homogeneous_bc) |
Functions to access solver parameters. | |
| virtual void | setInitialGuessNonzero (bool initial_guess_nonzero=true) |
| Set whether the initial guess is non-zero. More... | |
| virtual bool | getInitialGuessNonzero () const |
| Get whether the initial guess is non-zero. More... | |
Logging functions. | |
| bool | d_initial_guess_nonzero = true |
| bool | d_nullspace_contains_constant_vec = false |
| std::vector< SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > > | d_nullspace_basis_vecs |
| virtual void | printClassData (std::ostream &stream) override |
| Print class data to stream. More... | |
Linear solver functionality. | |
| SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > | d_hierarchy |
| Associated hierarchy. More... | |
| int | d_level_num = IBTK::invalid_level_number |
| Associated patch level and C-F boundary (for level numbers > 0). More... | |
| SAMRAI::tbox::Pointer< SAMRAI::hier::PatchLevel< NDIM > > | d_level |
| SAMRAI::tbox::Pointer< SAMRAI::hier::CoarseFineBoundary< NDIM > > | d_cf_boundary |
| SAMRAIDataCache | d_cached_eulerian_data |
| Scratch data. More... | |
| void | setNullSpace (bool contains_constant_vec, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > > &nullspace_basis_vecs=std::vector< SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > >()) override |
| Set the nullspace of the linear system. More... | |
| bool | solveSystem (SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override |
| Solve the linear system of equations \(Ax=b\) for \(x\). More... | |
| void | initializeSolverState (const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override |
| Compute hierarchy dependent data required for solving \(Ax=b\). More... | |
| void | deallocateSolverState () override |
| Remove all hierarchy dependent data allocated by initializeSolverState(). More... | |
| void | init (SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, const std::string &default_options_prefix) |
| Basic initialization. More... | |
| virtual void | generateASMSubdomains (std::vector< std::set< int > > &overlap_is, std::vector< std::set< int > > &nonoverlap_is) |
| Generate IS/subdomains for Schwartz type preconditioners. More... | |
| virtual void | generateFieldSplitSubdomains (std::vector< std::string > &field_names, std::vector< std::set< int > > &field_is) |
| Generate IS/subdomains for fieldsplit type preconditioners. More... | |
| virtual void | initializeSolverStateSpecialized (const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b)=0 |
| Compute hierarchy dependent data required for solving \(Ax=b\). More... | |
| virtual void | deallocateSolverStateSpecialized ()=0 |
| Remove all hierarchy dependent data allocated by initializeSolverStateSpecialized(). More... | |
| virtual void | copyToPETScVec (Vec &petsc_x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x)=0 |
| Copy a generic vector to the PETSc representation. More... | |
| virtual void | copyFromPETScVec (Vec &petsc_x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x)=0 |
| Copy a generic vector from the PETSc representation. More... | |
| virtual void | setupKSPVecs (Vec &petsc_x, Vec &petsc_b, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b)=0 |
| Copy solution and right-hand-side data to the PETSc representation, including any modifications to account for boundary conditions. More... | |
| virtual void | setupNullSpace () |
| Setup the solver nullspace (if any). More... | |
Field split preconditioner. | |
| std::vector< std::string > | d_field_name |
| std::vector< IS > | d_field_is |
| PETScLevelSolver (const PETScLevelSolver &from) | |
| Copy constructor. More... | |
| PETScLevelSolver & | operator= (const PETScLevelSolver &that)=delete |
| Assignment operator. More... | |
| static PetscErrorCode | PCApply_Additive (PC pc, Vec x, Vec y) |
| Apply the preconditioner to x and store the result in y. More... | |
| static PetscErrorCode | PCApply_Multiplicative (PC pc, Vec x, Vec y) |
| Apply the preconditioner to x and store the result in y. More... | |
| static PetscErrorCode | PCApply_RedBlackMultiplicative (PC pc, Vec x, Vec y) |
| Apply the preconditioner to x and store the result in y. More... | |
Sample parameters for initialization from database (and their default values):
options_prefix = "" // see setOptionsPrefix() ksp_type = "gmres" // see setKSPType() initial_guess_nonzero = TRUE // see setInitialGuessNonzero() rel_residual_tol = 1.0e-5 // see setRelativeTolerance() abs_residual_tol = 1.0e-50 // see setAbsoluteTolerance() max_iterations = 10000 // see setMaxIterations() enable_logging = FALSE // see setLoggingEnabled()
PETSc is developed at the Argonne National Laboratory Mathematics and Computer Science Division. For more information about PETSc, see http://www.mcs.anl.gov/petsc.
| IBTK::PETScLevelSolver::PETScLevelSolver | ( | ) |
| IBTK::PETScLevelSolver::~PETScLevelSolver | ( | ) |
|
private |
| from | The value to copy to this object. |
| void IBTK::PETScLevelSolver::setKSPType | ( | const std::string & | ksp_type | ) |
| void IBTK::PETScLevelSolver::setOptionsPrefix | ( | const std::string & | options_prefix | ) |
| const KSP& IBTK::PETScLevelSolver::getPETScKSP | ( | ) | const |
| void IBTK::PETScLevelSolver::getASMSubdomains | ( | std::vector< IS > ** | nonoverlapping_subdomains, |
| std::vector< IS > ** | overlapping_subdomains | ||
| ) |
|
overridevirtual |
Reimplemented from IBTK::LinearSolver.
|
overridevirtual |
Before calling solveSystem(), the form of the solution x and right-hand-side b vectors must be set properly by the user on all patch interiors on the specified range of levels in the patch hierarchy. The user is responsible for all data management for the quantities associated with the solution and right-hand-side vectors. In particular, patch data in these vectors must be allocated prior to calling this method.
| x | solution vector |
| b | right-hand-side vector |
Conditions on Parameters:
true if the solver converged to the specified tolerances, false otherwise Implements IBTK::GeneralSolver.
|
overridevirtual |
By default, the solveSystem() method computes some required hierarchy dependent data before solving and removes that data after the solve. For multiple solves that use the same hierarchy configuration, it is more efficient to:
Note that it is generally necessary to reinitialize the solver state when the hierarchy configuration changes.
| x | solution vector |
| b | right-hand-side vector |
Conditions on Parameters:
Reimplemented from IBTK::GeneralSolver.
|
overridevirtual |
Reimplemented from IBTK::GeneralSolver.
|
protected |
|
protectedvirtual |
Reimplemented in IBTK::CCPoissonPETScLevelSolver, IBTK::SCPoissonPETScLevelSolver, and IBAMR::StaggeredStokesPETScLevelSolver.
|
protectedvirtual |
Reimplemented in IBAMR::StaggeredStokesPETScLevelSolver.
|
protectedpure virtual |
|
protectedpure virtual |
|
protectedpure virtual |
|
protectedpure virtual |
|
protectedpure virtual |
|
protectedvirtual |
|
privatedelete |
| that | The value to assign to this object. |
|
staticprivate |
|
staticprivate |
|
staticprivate |
|
virtualinherited |
|
virtualinherited |
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
overridevirtualinherited |
Reimplemented from IBTK::GeneralSolver.
|
inherited |
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::FACPreconditioner, IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBAMR::CIBStaggeredStokesSolver, IBTK::FACPreconditioner, IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBAMR::CIBStaggeredStokesSolver, IBTK::FACPreconditioner, IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::BGaussSeidelPreconditioner, IBTK::PETScPCLSWrapper, and IBTK::BJacobiPreconditioner.
|
virtualinherited |
Reimplemented in IBTK::BGaussSeidelPreconditioner, IBTK::PETScPCLSWrapper, and IBTK::BJacobiPreconditioner.
|
virtualinherited |
|
virtualinherited |
|
protectedinherited |
|
protectedvirtualinherited |
Reimplemented in IBTK::PoissonSolver.
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
1.8.17