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

Class CIBStaggeredStokesSolver is an extension of IBAMR::StaggeredStokesSolver class that solves for the Langrange multiplier field $ \vec{\lambda} $ which imposes the rigidity constraint and solves for rigid body velocity (if it is freely-moving) along with the fluid velocity and pressure. More...

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

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

Public Member Functions

 CIBStaggeredStokesSolver (const std::string &object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, SAMRAI::tbox::Pointer< IBAMR::INSStaggeredHierarchyIntegrator > navier_stokes_integrator, SAMRAI::tbox::Pointer< IBAMR::CIBStrategy > cib_strategy, const std::string &default_options_prefix)
 Constructor.
 
 ~CIBStaggeredStokesSolver ()
 Destructor.
 
virtual void initializeSolverState (const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override
 
virtual void deallocateSolverState () override
 
virtual bool solveSystem (SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override
 Solve the system of equations. More...
 
virtual 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 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...
 
virtual void setPhysicalBoundaryHelper (SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelper > bc_helper) override
 Set the StaggeredStokesPhysicalBoundaryHelper object to be used in the StokesOperator.
 
virtual void setSolutionTime (double solution_time) override
 Set the time at which the solution is to be evaluated.
 
virtual void setTimeInterval (double current_time, double new_time) override
 Set the current time interval.
 
SAMRAI::tbox::Pointer< IBAMR::CIBSaddlePointSolvergetSaddlePointSolver () const
 Get the saddle-point solver for the extended Stokes system.
 
- 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.
 
- 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 double getSolutionTime () const
 Get the time at which the solution is being evaluated.
 
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 void setMaxIterations (int max_iterations)
 Set the maximum number of nonlinear iterations to use per solve.
 
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.
 
virtual void printClassData (std::ostream &stream)
 Print class data to stream.
 

Additional Inherited Members

- 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::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
 
- 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
 

Detailed Description

Class CIBStaggeredStokesSolver is an extension of IBAMR::StaggeredStokesSolver class that solves for the Langrange multiplier field $ \vec{\lambda} $ which imposes the rigidity constraint and solves for rigid body velocity (if it is freely-moving) along with the fluid velocity and pressure.

Member Function Documentation

◆ deallocateSolverState()

void IBAMR::CIBStaggeredStokesSolver::deallocateSolverState ( )
overridevirtual

Deallocate the solver when hierarchy changes.

Reimplemented from IBTK::GeneralSolver.

◆ initializeSolverState()

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

Initialize the solver before solving the system of equations.

Reimplemented from IBTK::GeneralSolver.

◆ setPhysicalBcCoefs()

void IBAMR::CIBStaggeredStokesSolver::setPhysicalBcCoefs ( const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &  u_bc_coefs,
SAMRAI::solv::RobinBcCoefStrategy< NDIM > *  p_bc_coef 
)
overridevirtual

Set the SAMRAI::solv::RobinBcCoefStrategy objects used to specify physical boundary conditions.

Note
Any of the elements of u_bc_coefs may be NULL. In this case, homogeneous Dirichlet boundary conditions are employed for that data depth. P_bc_coef may also be NULL; in that case, homogeneous Neumann boundary conditions are employed for the pressure.
Parameters
u_bc_coefsVector 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.

◆ solveSystem()

bool IBAMR::CIBStaggeredStokesSolver::solveSystem ( SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  x,
SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  b 
)
overridevirtual

Solve the system of equations.

Returns
true if the solver converged to the specified tolerances, false otherwise.

Implements IBTK::GeneralSolver.


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