IBAMR  IBAMR version 0.19.
Public Member Functions | Protected Attributes | Private Member Functions | Private Attributes | List of all members
IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver Class Reference

Partial solver for the Stokes-IB equations. More...

Inheritance diagram for IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver:
Inheritance graph
[legend]

Public Member Functions

 IBImplicitStaggeredStokesSolver (const std::string &object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db)
 Class constructor. More...
 
 ~IBImplicitStaggeredStokesSolver ()
 Class desctructor. More...
 
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. More...
 
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 setPhysicalBoundaryHelper (SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelper > bc_helper) override
 Set the StokesSpecifications object and timestep size used to specify the coefficients for the time-dependent incompressible Stokes operator. More...
 
void setComponentsHaveNullSpace (const bool has_velocity_nullspace, const bool has_pressure_nullspace) override
 Set if velocity and pressure have nullspace. More...
 
bool solveSystem (SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &) override
 Solve the system of equations. More...
 
SAMRAI::tbox::Pointer< StaggeredStokesOperatorgetStaggeredStokesOperator ()
 
SAMRAI::tbox::Pointer< StaggeredStokesFACPreconditionergetStaggeredStokesFACPreconditioner ()
 

Protected Attributes

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
 

Private Member Functions

 IBImplicitStaggeredStokesSolver ()=delete
 
 IBImplicitStaggeredStokesSolver (const IBImplicitStaggeredStokesSolver &from)=delete
 
IBImplicitStaggeredStokesSolveroperator= (const IBImplicitStaggeredStokesSolver &that)=delete
 

Private Attributes

SAMRAI::tbox::Pointer< StaggeredStokesOperatord_stokes_op
 
SAMRAI::tbox::Pointer< StaggeredStokesFACPreconditionerd_stokes_fac_pc
 

General-purpose solver functionality.

const std::string & getName () const
 Return the object name. More...
 
virtual bool getIsInitialized () const
 Return whether the operator is initialized. More...
 
virtual void setHomogeneousBc (bool homogeneous_bc)
 Set whether the solver should use homogeneous boundary conditions. More...
 
virtual bool getHomogeneousBc () const
 Return whether the solver is using homogeneous boundary conditions. More...
 
virtual void setSolutionTime (double solution_time)
 Set the time at which the solution is to be evaluated. More...
 
virtual double getSolutionTime () const
 Get the time at which the solution is being evaluated. More...
 
virtual void setTimeInterval (double current_time, double new_time)
 Set the current time interval. More...
 
virtual std::pair< double, doublegetTimeInterval () const
 Get the current time interval. More...
 
virtual double getDt () const
 Get the current time step size. More...
 
virtual void setHierarchyMathOps (SAMRAI::tbox::Pointer< HierarchyMathOps > hier_math_ops)
 Set the HierarchyMathOps object used by the solver. More...
 
virtual SAMRAI::tbox::Pointer< HierarchyMathOps > getHierarchyMathOps () const
 Get the HierarchyMathOps object used by the solver. More...
 
virtual void initializeSolverState (const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b)
 Compute hierarchy dependent data required for solving \(F[x]=b\). More...
 
virtual void deallocateSolverState ()
 Remove all hierarchy dependent data allocated by initializeSolverState(). 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.

virtual void setLoggingEnabled (bool enable_logging=true)
 Enable or disable logging. More...
 
virtual bool getLoggingEnabled () const
 Determine whether logging is enabled or disabled. More...
 
virtual void printClassData (std::ostream &stream)
 Print class data to stream. More...
 
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
 
void init (const std::string &object_name, bool homogeneous_bc)
 
virtual void initSpecialized (const std::string &object_name, bool homogeneous_bc)
 

Detailed Description

Note
This class is designed to be used internally by class IBImplicitStaggeredHierarchyIntegrator. It is not meant to be a stand-alone solver.

Constructor & Destructor Documentation

◆ IBImplicitStaggeredStokesSolver() [1/3]

IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::IBImplicitStaggeredStokesSolver ( const std::string &  object_name,
SAMRAI::tbox::Pointer< SAMRAI::tbox::Database input_db 
)
inline

◆ ~IBImplicitStaggeredStokesSolver()

IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::~IBImplicitStaggeredStokesSolver ( )
inline

◆ IBImplicitStaggeredStokesSolver() [2/3]

IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::IBImplicitStaggeredStokesSolver ( )
privatedelete

◆ IBImplicitStaggeredStokesSolver() [3/3]

IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::IBImplicitStaggeredStokesSolver ( const IBImplicitStaggeredStokesSolver from)
privatedelete

Member Function Documentation

◆ setVelocityPoissonSpecifications()

void IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::setVelocityPoissonSpecifications ( const SAMRAI::solv::PoissonSpecifications U_problem_coefs)
inlineoverridevirtual

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ setPhysicalBcCoefs()

void IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::setPhysicalBcCoefs ( const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &  U_bc_coefs,
SAMRAI::solv::RobinBcCoefStrategy< NDIM > *  P_bc_coef 
)
inlineoverridevirtual
Note
Any of the elements of U_bc_coefs may be nullptr. In this case, homogeneous Dirichlet boundary conditions are employed for that data depth. P_bc_coef may also be nullptr; in that case, homogeneous Neumann boundary conditions are employed for the pressure.
Parameters
U_bc_coefsIBTK::Vector of pointers to objects that can set the Robin boundary condition coefficients for the velocity
P_bc_coefPointer to object that can set the Robin boundary condition coefficients for the pressure

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ setPhysicalBoundaryHelper()

void IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::setPhysicalBoundaryHelper ( SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelper bc_helper)
inlineoverridevirtual

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ setComponentsHaveNullSpace()

void IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::setComponentsHaveNullSpace ( const bool  has_velocity_nullspace,
const bool  has_pressure_nullspace 
)
inlineoverridevirtual

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ solveSystem()

bool IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::solveSystem ( SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  x,
SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  b 
)
inlineoverridevirtual

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.

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
Subclasses must be implemented so that the vector arguments for solveSystem() need not match those for initializeSolverState(). However, they are allowed to require a certain degree of similarity, including:
  • hierarchy configuration (hierarchy pointer and range of levels)
  • number, type and alignment of vector component data
  • ghost cell widths of data in the solution x and right-hand-side b vectors
Note
Subclasses are required to be implemented so that the solver does not need to be initialized prior to calling solveSystem(); however, see initializeSolverState() and deallocateSolverState() for opportunities to save overhead when performing multiple consecutive solves.
See also
initializeSolverState
deallocateSolverState
Returns
true if the solver converged to the specified tolerances, false otherwise

Implements IBTK::GeneralSolver.

◆ getStaggeredStokesOperator()

SAMRAI::tbox::Pointer<StaggeredStokesOperator> IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::getStaggeredStokesOperator ( )
inline

◆ getStaggeredStokesFACPreconditioner()

SAMRAI::tbox::Pointer<StaggeredStokesFACPreconditioner> IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::getStaggeredStokesFACPreconditioner ( )
inline

◆ operator=()

IBImplicitStaggeredStokesSolver& IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::operator= ( const IBImplicitStaggeredStokesSolver that)
privatedelete

◆ getName()

const std::string& IBTK::GeneralSolver::getName ( ) const
inherited

◆ getIsInitialized()

virtual bool IBTK::GeneralSolver::getIsInitialized ( ) const
virtualinherited

◆ setHomogeneousBc()

virtual void IBTK::GeneralSolver::setHomogeneousBc ( bool  homogeneous_bc)
virtualinherited

◆ getHomogeneousBc()

virtual bool IBTK::GeneralSolver::getHomogeneousBc ( ) const
virtualinherited

◆ setSolutionTime()

virtual void IBTK::GeneralSolver::setSolutionTime ( double  solution_time)
virtualinherited

◆ getSolutionTime()

virtual double IBTK::GeneralSolver::getSolutionTime ( ) const
virtualinherited

◆ setTimeInterval()

virtual void IBTK::GeneralSolver::setTimeInterval ( double  current_time,
double  new_time 
)
virtualinherited

◆ getTimeInterval()

virtual std::pair<double, double> IBTK::GeneralSolver::getTimeInterval ( ) const
virtualinherited

◆ getDt()

virtual double IBTK::GeneralSolver::getDt ( ) const
virtualinherited

◆ setHierarchyMathOps()

virtual void IBTK::GeneralSolver::setHierarchyMathOps ( SAMRAI::tbox::Pointer< HierarchyMathOps hier_math_ops)
virtualinherited

◆ getHierarchyMathOps()

virtual SAMRAI::tbox::Pointer<HierarchyMathOps> IBTK::GeneralSolver::getHierarchyMathOps ( ) const
virtualinherited

◆ initializeSolverState()

virtual void IBTK::GeneralSolver::initializeSolverState ( const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  x,
const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  b 
)
virtualinherited

In a typical implementation, the solveSystem() method will compute some required hierarchy dependent data before the solve, and then remove that data after the solve. For multiple solves that use the same hierarchy configuration, it is more efficient to:

  1. initialize the hierarchy-dependent data required by the solver via initializeSolverState(),
  2. solve the system one or more times via solveSystem(), and
  3. remove the hierarchy-dependent data via deallocateSolverState().

Note that it is generally necessary to reinitialize the solver state when the hierarchy configuration changes.

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
Subclasses must be implemented so that the vector arguments for solveSystem() need not match those for initializeSolverState(). However, they are allowed to require a certain degree of similarity, including:
  • hierarchy configuration (hierarchy pointer and range of levels)
  • number, type and alignment of vector component data
  • ghost cell widths of data in the solution x and right-hand-side b vectors
Note
Subclasses are required to be implemented so that it is safe to call initializeSolverState() when the solver state is already initialized. In this case, the solver state should be first deallocated and then reinitialized.
Subclasses are required to be implemented so that when any operator objects have been registered with the solver via setOperator() or setJacobian(), they are also initialized by initializeSolverState().
See also
deallocateSolverState

Reimplemented in IBTK::PETScKrylovLinearSolver, IBTK::PETScNewtonKrylovSolver, IBTK::CCPoissonHypreLevelSolver, IBTK::SCPoissonHypreLevelSolver, IBTK::BGaussSeidelPreconditioner, IBTK::PETScLevelSolver, IBTK::FACPreconditioner, IBTK::BJacobiPreconditioner, IBAMR::StaggeredStokesBlockPreconditioner, IBTK::PETScPCLSWrapper, IBAMR::StaggeredStokesBlockFactorizationPreconditioner, IBAMR::StaggeredStokesProjectionPreconditioner, IBAMR::VCStaggeredStokesProjectionPreconditioner, and IBAMR::CIBStaggeredStokesSolver.

◆ deallocateSolverState()

virtual void IBTK::GeneralSolver::deallocateSolverState ( )
virtualinherited
Note
Subclasses are required to be implemented so that it is safe to call deallocateSolverState() when the solver state is already deallocated.
Subclasses are required to be implemented so that when any operator objects have been registered with the solver via setOperator() or setJacobian(), they are also deallocated by deallocateSolverState().
See also
initializeSolverState

Reimplemented in IBTK::PETScKrylovLinearSolver, IBTK::PETScNewtonKrylovSolver, IBTK::CCPoissonHypreLevelSolver, IBTK::SCPoissonHypreLevelSolver, IBTK::BGaussSeidelPreconditioner, IBTK::PETScLevelSolver, IBTK::FACPreconditioner, IBTK::BJacobiPreconditioner, IBAMR::StaggeredStokesBlockPreconditioner, IBTK::PETScPCLSWrapper, IBAMR::StaggeredStokesBlockFactorizationPreconditioner, IBAMR::StaggeredStokesProjectionPreconditioner, IBAMR::VCStaggeredStokesProjectionPreconditioner, and IBAMR::CIBStaggeredStokesSolver.

◆ setMaxIterations()

virtual void IBTK::GeneralSolver::setMaxIterations ( int  max_iterations)
virtualinherited

◆ getMaxIterations()

virtual int IBTK::GeneralSolver::getMaxIterations ( ) const
virtualinherited

Reimplemented in IBTK::PETScPCLSWrapper.

◆ setAbsoluteTolerance()

virtual void IBTK::GeneralSolver::setAbsoluteTolerance ( double  abs_residual_tol)
virtualinherited

Reimplemented in IBTK::PETScPCLSWrapper.

◆ getAbsoluteTolerance()

virtual double IBTK::GeneralSolver::getAbsoluteTolerance ( ) const
virtualinherited

Reimplemented in IBTK::PETScPCLSWrapper.

◆ setRelativeTolerance()

virtual void IBTK::GeneralSolver::setRelativeTolerance ( double  rel_residual_tol)
virtualinherited

Reimplemented in IBTK::PETScPCLSWrapper.

◆ getRelativeTolerance()

virtual double IBTK::GeneralSolver::getRelativeTolerance ( ) const
virtualinherited

Reimplemented in IBTK::PETScPCLSWrapper.

◆ getNumIterations()

virtual int IBTK::GeneralSolver::getNumIterations ( ) const
virtualinherited

◆ getResidualNorm()

virtual double IBTK::GeneralSolver::getResidualNorm ( ) const
virtualinherited

◆ setLoggingEnabled()

virtual void IBTK::GeneralSolver::setLoggingEnabled ( bool  enable_logging = true)
virtualinherited

◆ getLoggingEnabled()

virtual bool IBTK::GeneralSolver::getLoggingEnabled ( ) const
virtualinherited

◆ printClassData()

virtual void IBTK::GeneralSolver::printClassData ( std::ostream &  stream)
virtualinherited

Reimplemented in IBTK::LinearSolver.

◆ init()

void IBTK::GeneralSolver::init ( const std::string &  object_name,
bool  homogeneous_bc 
)
protectedinherited

◆ initSpecialized()

virtual void IBTK::GeneralSolver::initSpecialized ( const std::string &  object_name,
bool  homogeneous_bc 
)
protectedvirtualinherited

Reimplemented in IBTK::PoissonSolver.

Member Data Documentation

◆ d_stokes_op

SAMRAI::tbox::Pointer<StaggeredStokesOperator> IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::d_stokes_op
private

◆ d_stokes_fac_pc

SAMRAI::tbox::Pointer<StaggeredStokesFACPreconditioner> IBAMR::IBImplicitStaggeredHierarchyIntegrator::IBImplicitStaggeredStokesSolver::d_stokes_fac_pc
private

◆ d_U_problem_coefs

SAMRAI::solv::PoissonSpecifications IBAMR::StaggeredStokesSolver::d_U_problem_coefs
protectedinherited

◆ d_default_U_bc_coef

SAMRAI::solv::LocationIndexRobinBcCoefs<NDIM> IBAMR::StaggeredStokesSolver::d_default_U_bc_coef
protectedinherited

◆ d_U_bc_coefs

std::vector<SAMRAI::solv::RobinBcCoefStrategy<NDIM>*> IBAMR::StaggeredStokesSolver::d_U_bc_coefs
protectedinherited

◆ d_default_P_bc_coef

SAMRAI::solv::LocationIndexRobinBcCoefs<NDIM> IBAMR::StaggeredStokesSolver::d_default_P_bc_coef
protectedinherited

◆ d_P_bc_coef

SAMRAI::solv::RobinBcCoefStrategy<NDIM>* IBAMR::StaggeredStokesSolver::d_P_bc_coef
protectedinherited

◆ d_bc_helper

SAMRAI::tbox::Pointer<StaggeredStokesPhysicalBoundaryHelper> IBAMR::StaggeredStokesSolver::d_bc_helper
protectedinherited

◆ d_has_velocity_nullspace

bool IBAMR::StaggeredStokesSolver::d_has_velocity_nullspace = false
protectedinherited

◆ d_has_pressure_nullspace

bool IBAMR::StaggeredStokesSolver::d_has_pressure_nullspace = false
protectedinherited

◆ d_object_name

std::string IBTK::GeneralSolver::d_object_name = "unitialized"
protectedinherited

◆ d_is_initialized

bool IBTK::GeneralSolver::d_is_initialized = false
protectedinherited

◆ d_homogeneous_bc

bool IBTK::GeneralSolver::d_homogeneous_bc = false
protectedinherited

◆ d_solution_time

double IBTK::GeneralSolver::d_solution_time = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_current_time

double IBTK::GeneralSolver::d_current_time = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_new_time

double IBTK::GeneralSolver::d_new_time = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_rel_residual_tol

double IBTK::GeneralSolver::d_rel_residual_tol = 0.0
protectedinherited

◆ d_abs_residual_tol

double IBTK::GeneralSolver::d_abs_residual_tol = 0.0
protectedinherited

◆ d_max_iterations

int IBTK::GeneralSolver::d_max_iterations = 100
protectedinherited

◆ d_current_iterations

int IBTK::GeneralSolver::d_current_iterations = 0
protectedinherited

◆ d_current_residual_norm

double IBTK::GeneralSolver::d_current_residual_norm = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_hier_math_ops

SAMRAI::tbox::Pointer<HierarchyMathOps> IBTK::GeneralSolver::d_hier_math_ops
protectedinherited

◆ d_hier_math_ops_external

bool IBTK::GeneralSolver::d_hier_math_ops_external = false
protectedinherited

◆ d_enable_logging

bool IBTK::GeneralSolver::d_enable_logging = false
protectedinherited

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