IBAMR
An adaptive and distributed-memory parallel implementation of the immersed boundary (IB) method
Public Types | Public Member Functions | Static Public Member Functions | List of all members
IBAMR::StaggeredStokesBlockFactorizationPreconditioner Class Reference

Class StaggeredStokesBlockFactorizationPreconditioner is a concrete StaggeredStokesBlockPreconditioner that implements a staggered grid (MAC) block factorization (approximate Schur complement) preconditioner for the incompressible Stokes equations. More...

#include </home/runner/work/IBAMR/IBAMR/include/ibamr/StaggeredStokesBlockFactorizationPreconditioner.h>

Inheritance diagram for IBAMR::StaggeredStokesBlockFactorizationPreconditioner:
Inheritance graph
[legend]

Public Types

enum  FactorizationType { LOWER_TRIANGULAR , UPPER_TRIANGULAR , SYMMETRIC , DIAGONAL }
 

Public Member Functions

 StaggeredStokesBlockFactorizationPreconditioner (const std::string &object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, const std::string &default_options_prefix)
 Class constructor.
 
 ~StaggeredStokesBlockFactorizationPreconditioner ()
 Destructor.
 
void setFactorizationType (FactorizationType factorization_type)
 
Linear solver functionality.
bool solveSystem (SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override
 Compute the action of the preconditioner.
 
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...
 
- Public Member Functions inherited from IBAMR::StaggeredStokesBlockPreconditioner
 StaggeredStokesBlockPreconditioner (bool needs_velocity_solver, bool needs_pressure_solver)
 Constructor.
 
 ~StaggeredStokesBlockPreconditioner ()=default
 Destructor.
 
virtual bool needsVelocitySubdomainSolver () const
 Indicate whether the preconditioner needs a velocity subdomain solver.
 
virtual void setVelocitySubdomainSolver (SAMRAI::tbox::Pointer< IBTK::PoissonSolver > velocity_solver)
 Provide a velocity subdomain solver.
 
void setVelocityPoissonSpecifications (const SAMRAI::solv::PoissonSpecifications &U_problem_coefs) override
 Set the PoissonSpecifications object used to specify the coefficients for the momentum equation in the incompressible Stokes operator.
 
virtual bool needsPressureSubdomainSolver () const
 Indicate whether the preconditioner needs a pressure subdomain solver.
 
virtual void setPressureSubdomainSolver (SAMRAI::tbox::Pointer< IBTK::PoissonSolver > pressure_solver)
 Provide a pressure subdomain solver.
 
virtual void setPressurePoissonSpecifications (const SAMRAI::solv::PoissonSpecifications &P_problem_coefs)
 Set the PoissonSpecifications object used to specify the coefficients for the pressure-Poisson problem.
 
virtual void setPhysicalBcCoefs (const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &U_bc_coefs, SAMRAI::solv::RobinBcCoefStrategy< NDIM > *P_bc_coef) override
 Set the SAMRAI::solv::RobinBcCoefStrategy objects used to specify physical boundary conditions. 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...
 
- Public Member Functions inherited from IBTK::LinearSolver
 LinearSolver ()
 Constructor.
 
virtual ~LinearSolver ()
 Empty virtual destructor.
 
virtual void setNullspace (bool nullspace_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 > > >())
 Set the nullspace of the linear system. More...
 
virtual bool getNullspaceContainsConstantVector () const
 Get whether the nullspace of the linear system contains th constant vector.
 
virtual const std::vector< SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > > & getNullspaceBasisVectors () const
 Get the basis vectors for the nullspace of the linear system.
 
virtual bool getInitialGuessNonzero () const
 Get whether the initial guess is non-zero.
 
virtual void printClassData (std::ostream &stream) override
 Print class data to stream.
 
- Public Member Functions inherited from IBTK::GeneralSolver
 GeneralSolver ()=default
 Constructor.
 
virtual ~GeneralSolver ()=default
 Empty virtual destructor.
 
const std::stringgetName () const
 Return the object name.
 
virtual bool getIsInitialized () const
 Return whether the operator is initialized.
 
virtual void setHomogeneousBc (bool homogeneous_bc)
 Set whether the solver should use homogeneous boundary conditions.
 
virtual bool getHomogeneousBc () const
 Return whether the solver is using homogeneous boundary conditions.
 
virtual void setSolutionTime (double solution_time)
 Set the time at which the solution is to be evaluated.
 
virtual double getSolutionTime () const
 Get the time at which the solution is being evaluated.
 
virtual void setTimeInterval (double current_time, double new_time)
 Set the current time interval.
 
virtual std::pair< double, double > getTimeInterval () const
 Get the current time interval.
 
virtual double getDt () const
 Get the current time step size.
 
virtual void setHierarchyMathOps (SAMRAI::tbox::Pointer< HierarchyMathOps > hier_math_ops)
 Set the HierarchyMathOps object used by the solver.
 
virtual SAMRAI::tbox::Pointer< HierarchyMathOpsgetHierarchyMathOps () const
 Get the HierarchyMathOps object used by the solver.
 
virtual int getMaxIterations () const
 Get the maximum number of nonlinear iterations to use per solve.
 
virtual void setAbsoluteTolerance (double abs_residual_tol)
 Set the absolute residual tolerance for convergence.
 
virtual double getAbsoluteTolerance () const
 Get the absolute residual tolerance for convergence.
 
virtual void setRelativeTolerance (double rel_residual_tol)
 Set the relative residual tolerance for convergence.
 
virtual double getRelativeTolerance () const
 Get the relative residual tolerance for convergence.
 
virtual int getNumIterations () const
 Return the iteration count from the most recent solve.
 
virtual double getResidualNorm () const
 Return the residual norm from the most recent iteration.
 
virtual void setLoggingEnabled (bool enable_logging=true)
 Enable or disable logging.
 
virtual bool getLoggingEnabled () const
 Determine whether logging is enabled or disabled.
 
- Public Member Functions inherited from IBAMR::StaggeredStokesSolver
 StaggeredStokesSolver ()
 Deafult constructor.
 
 ~StaggeredStokesSolver ()=default
 Destructor.
 
virtual void setComponentsHaveNullspace (const bool has_velocity_nullspace, const bool has_pressure_nullspace)
 Set if velocity and pressure have nullspace.
 
virtual void setPhysicalBoundaryHelper (SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelper > bc_helper)
 Set the StokesSpecifications object and timestep size used to specify the coefficients for the time-dependent incompressible Stokes operator.
 

Static Public Member Functions

static SAMRAI::tbox::Pointer< StaggeredStokesSolverallocate_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 StaggeredStokesBlockFactorizationPreconditioner.
 

Functions to access solver parameters.

void setInitialGuessNonzero (bool initial_guess_nonzero=true) override
 Set whether the initial guess is non-zero.
 
void setMaxIterations (int max_iterations) override
 Set the maximum number of iterations to use per solve.
 

Additional Inherited Members

- Protected Member Functions inherited from IBAMR::StaggeredStokesBlockPreconditioner
void correctNullspace (SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > U_vec, SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > P_vec)
 Remove components in operator null space.
 
- Protected Member Functions inherited from IBTK::GeneralSolver
void init (const std::string &object_name, bool homogeneous_bc)
 
virtual void initSpecialized (const std::string &object_name, bool homogeneous_bc)
 
- Protected Attributes inherited from IBAMR::StaggeredStokesBlockPreconditioner
const bool d_needs_velocity_solver
 
SAMRAI::tbox::Pointer< IBTK::PoissonSolverd_velocity_solver
 
SAMRAI::solv::PoissonSpecifications d_P_problem_coefs
 
const bool d_needs_pressure_solver
 
SAMRAI::tbox::Pointer< IBTK::PoissonSolverd_pressure_solver
 
SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > d_hierarchy
 
int d_coarsest_ln = IBTK::invalid_level_number
 
int d_finest_ln = IBTK::invalid_level_number
 
SAMRAI::tbox::Pointer< SAMRAI::math::HierarchyDataOpsReal< NDIM, double > > d_velocity_data_ops
 
SAMRAI::tbox::Pointer< SAMRAI::math::HierarchyDataOpsReal< NDIM, double > > d_pressure_data_ops
 
int d_velocity_wgt_idx = IBTK::invalid_index
 
int d_pressure_wgt_idx = IBTK::invalid_index
 
SAMRAI::tbox::Pointer< IBTK::HierarchyMathOpsd_hier_math_ops
 
- Protected Attributes inherited from IBTK::LinearSolver
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
 
- Protected Attributes inherited from IBTK::GeneralSolver
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< HierarchyMathOpsd_hier_math_ops
 
bool d_hier_math_ops_external = false
 
bool d_enable_logging = false
 
- Protected Attributes inherited from IBAMR::StaggeredStokesSolver
SAMRAI::solv::PoissonSpecifications d_U_problem_coefs
 
SAMRAI::solv::LocationIndexRobinBcCoefs< NDIM > d_default_U_bc_coef
 
std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > d_U_bc_coefs
 
SAMRAI::solv::LocationIndexRobinBcCoefs< NDIM > d_default_P_bc_coef
 
SAMRAI::solv::RobinBcCoefStrategy< NDIM > * d_P_bc_coef
 
SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelperd_bc_helper
 
bool d_has_velocity_nullspace = false
 
bool d_has_pressure_nullspace = false
 

Detailed Description

Class StaggeredStokesBlockFactorizationPreconditioner is a concrete StaggeredStokesBlockPreconditioner that implements a staggered grid (MAC) block factorization (approximate Schur complement) preconditioner for the incompressible Stokes equations.

See also
INSStaggeredHierarchyIntegrator

Member Function Documentation

◆ deallocateSolverState()

void IBAMR::StaggeredStokesBlockFactorizationPreconditioner::deallocateSolverState ( )
overridevirtual

Remove all hierarchy dependent data allocated by initializeSolverState().

Note
It is safe to call deallocateSolverState() when the solver state is already deallocated.
See also
initializeSolverState
Note
A default implementation is provided which does nothing.

Reimplemented from IBTK::GeneralSolver.

◆ initializeSolverState()

void IBAMR::StaggeredStokesBlockFactorizationPreconditioner::initializeSolverState ( const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  x,
const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  b 
)
overridevirtual

Compute hierarchy dependent data required for solving $Ax=b$.

Parameters
xsolution vector
bright-hand-side vector

Conditions on Parameters:

  • vectors x and b must have same patch hierarchy
  • vectors x and b must have same structure, depth, etc.
Note
It is safe to call initializeSolverState() when the solver state is already initialized.
See also
deallocateSolverState
Note
A default implementation is provided which does nothing.

Reimplemented from IBTK::GeneralSolver.

◆ setFactorizationType()

void IBAMR::StaggeredStokesBlockFactorizationPreconditioner::setFactorizationType ( FactorizationType  factorization_type)

Set the factorization type.


The documentation for this class was generated from the following files: