|
IBAMR
IBAMR version 0.19.
|
Class SCPoissonPETScLevelSolver is a concrete PETScLevelSolver for solving elliptic equations of the form \( \mbox{$L u$} = \mbox{$(C I + \nabla \cdot D \nabla) u$} = f \) on a single SAMRAI::hier::PatchLevel using PETSc. More...
#include <ibtk/SCPoissonPETScLevelSolver.h>

Public Member Functions | |
| SCPoissonPETScLevelSolver (const std::string &object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, std::string default_options_prefix) | |
| Constructor. More... | |
| ~SCPoissonPETScLevelSolver () | |
| 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... | |
| virtual void | setPoissonSpecifications (const SAMRAI::solv::PoissonSpecifications &poisson_spec) |
| Set the SAMRAI::solv::PoissonSpecifications object used to specify the coefficients for the scalar-valued or vector-valued Laplace operator. More... | |
| virtual void | setPhysicalBcCoef (SAMRAI::solv::RobinBcCoefStrategy< NDIM > *bc_coef) |
| Set the SAMRAI::solv::RobinBcCoefStrategy object used to specify physical boundary conditions. More... | |
| virtual void | setPhysicalBcCoefs (const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &bc_coefs) |
| Set the SAMRAI::solv::RobinBcCoefStrategy objects used to specify physical boundary conditions. More... | |
Static Public Member Functions | |
| static SAMRAI::tbox::Pointer< PoissonSolver > | allocate_solver (const std::string &object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, const std::string &default_options_prefix) |
| Static function to construct a SCPoissonPETScLevelSolver. More... | |
Protected Member Functions | |
| void | generateASMSubdomains (std::vector< std::set< int > > &overlap_is, std::vector< std::set< int > > &nonoverlap_is) override |
| Generate IS/subdomains for Schwartz type preconditioners. More... | |
| void | initializeSolverStateSpecialized (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 | deallocateSolverStateSpecialized () override |
| Remove all hierarchy dependent data allocated by initializeSolverStateSpecialized(). More... | |
| void | copyToPETScVec (Vec &petsc_x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x) override |
| Copy a generic vector to the PETSc representation. More... | |
| void | copyFromPETScVec (Vec &petsc_x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x) override |
| Copy a generic vector from the PETSc representation. More... | |
| void | setupKSPVecs (Vec &petsc_x, Vec &petsc_b, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override |
| Copy solution and right-hand-side data to the PETSc representation, including any modifications to account for boundary conditions. More... | |
| void | initSpecialized (const std::string &object_name, bool homogeneous_bc) override |
Protected Attributes | |
| SAMRAI::solv::PoissonSpecifications | d_poisson_spec = SAMRAI::solv::PoissonSpecifications("") |
| std::unique_ptr< SAMRAI::solv::RobinBcCoefStrategy< NDIM > > | d_default_bc_coef |
| std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > | d_bc_coefs |
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 | generateFieldSplitSubdomains (std::vector< std::string > &field_names, std::vector< std::set< int > > &field_is) |
| Generate IS/subdomains for fieldsplit type preconditioners. 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 |
| 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... | |
PETSc objects. | |
| SAMRAI::tbox::Pointer< SAMRAI::hier::VariableContext > | d_context |
| std::vector< int > | d_num_dofs_per_proc |
| int | d_dof_index_idx = IBTK::invalid_index |
| SAMRAI::tbox::Pointer< SAMRAI::pdat::SideVariable< NDIM, int > > | d_dof_index_var |
| SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > | d_data_synch_sched |
| SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > | d_ghost_fill_sched |
| SCPoissonPETScLevelSolver ()=delete | |
| Default constructor. More... | |
| SCPoissonPETScLevelSolver (const SCPoissonPETScLevelSolver &from)=delete | |
| Copy constructor. More... | |
| SCPoissonPETScLevelSolver & | operator= (const SCPoissonPETScLevelSolver &that)=delete |
| Assignment operator. More... | |
This solver class uses the PETSc library to solve linear equations of the form \( (C I + \nabla \cdot D \nabla ) u = f \), where \(C\) and \(D\) are scalars, and \(u\) and \(f\) are side-centered arrays. The discretization is second-order accurate.
Robin boundary conditions may be specified through the interface class SAMRAI::solv::RobinBcCoefStrategy.
The user must perform the following steps to use class SCPoissonPETScLevelSolver:
Sample parameters for initialization from database (and their default values):
max_iterations = 10 // see setMaxIterations() absolute_residual_tol = 0.0 // see setAbsoluteTolerance() (only used by hypre Krylov solvers) rel_residual_tol = 1.0e-6 // see setRelativeTolerance() enable_logging = FALSE // see setLoggingEnabled() options_prefix = "" // see setOptionsPrefix()
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::SCPoissonPETScLevelSolver::SCPoissonPETScLevelSolver | ( | const std::string & | object_name, |
| SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > | input_db, | ||
| std::string | default_options_prefix | ||
| ) |
| IBTK::SCPoissonPETScLevelSolver::~SCPoissonPETScLevelSolver | ( | ) |
|
privatedelete |
|
privatedelete |
| from | The value to copy to this object. |
|
inlinestatic |
|
overrideprotectedvirtual |
Reimplemented from IBTK::PETScLevelSolver.
|
overrideprotectedvirtual |
Implements IBTK::PETScLevelSolver.
Reimplemented in IBTK::VCSCViscousPETScLevelSolver.
|
overrideprotectedvirtual |
Implements IBTK::PETScLevelSolver.
|
overrideprotectedvirtual |
Implements IBTK::PETScLevelSolver.
|
overrideprotectedvirtual |
Implements IBTK::PETScLevelSolver.
|
overrideprotectedvirtual |
Implements IBTK::PETScLevelSolver.
Reimplemented in IBTK::VCSCViscousPETScLevelSolver.
|
privatedelete |
| that | The value to assign to this object. |
|
inherited |
|
inherited |
|
inherited |
|
inherited |
|
overridevirtualinherited |
Reimplemented from IBTK::LinearSolver.
|
overridevirtualinherited |
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.
|
overridevirtualinherited |
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.
|
overridevirtualinherited |
Reimplemented from IBTK::GeneralSolver.
|
protectedinherited |
|
protectedinherited |
|
protectedvirtualinherited |
Reimplemented in IBAMR::StaggeredStokesPETScLevelSolver.
|
protectedvirtualinherited |
|
staticprivateinherited |
|
staticprivateinherited |
|
staticprivateinherited |
|
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 |
|
protectedvirtualinherited |
Reimplemented in IBTK::PoissonSolver.
|
virtualinherited |
Reimplemented in IBTK::PoissonFACPreconditioner, and IBTK::KrylovLinearSolverPoissonSolverInterface.
|
virtualinherited |
| bc_coef | Pointer to an object that can set the Robin boundary condition coefficients |
Reimplemented in IBTK::PoissonFACPreconditioner, and IBTK::KrylovLinearSolverPoissonSolverInterface.
|
virtualinherited |
| bc_coefs | Vector of pointers to objects that can set the Robin boundary condition coefficients |
Reimplemented in IBTK::PoissonFACPreconditioner, and IBTK::KrylovLinearSolverPoissonSolverInterface.
|
overrideprotectedvirtualinherited |
Reimplemented from IBTK::GeneralSolver.
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
1.8.17