IBAMR  IBAMR version 0.19.
Public Member Functions | Protected Attributes | Private Member Functions | Private Attributes | 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.

#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. More...
 
 ~CIBStaggeredStokesSolver ()
 Destructor. More...
 
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. More...
 
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. More...
 
virtual void setSolutionTime (double solution_time) override
 Set the time at which the solution is to be evaluated. More...
 
virtual void setTimeInterval (double current_time, double new_time) override
 Set the current time interval. More...
 
SAMRAI::tbox::Pointer< IBAMR::CIBSaddlePointSolvergetSaddlePointSolver () const
 Get the saddle-point solver for the extended Stokes system. More...
 
virtual void setComponentsHaveNullSpace (const bool has_velocity_nullspace, const bool has_pressure_nullspace)
 Set if velocity and pressure have nullspace. More...
 

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

 CIBStaggeredStokesSolver (const CIBStaggeredStokesSolver &from)=delete
 Copy constructor. More...
 
CIBStaggeredStokesSolveroperator= (const CIBStaggeredStokesSolver &that)=delete
 Assignment operator. More...
 

Private Attributes

SAMRAI::tbox::Pointer< CIBStrategyd_cib_strategy
 
const unsigned int d_num_rigid_parts
 
SAMRAI::tbox::Pointer< IBAMR::CIBSaddlePointSolverd_sp_solver
 
SAMRAI::tbox::Pointer< SAMRAI::pdat::SideVariable< NDIM, double > > d_wide_u_var
 
SAMRAI::tbox::Pointer< SAMRAI::pdat::SideVariable< NDIM, double > > d_wide_f_var
 
SAMRAI::tbox::Pointer< SAMRAI::hier::VariableContextd_wide_ctx
 
int d_wide_u_idx = IBTK::invalid_index
 
int d_wide_f_idx = IBTK::invalid_index
 
SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > d_x_wide
 
SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > d_b_wide
 
bool d_is_initialized = false
 
bool d_reinitializing_solver = false
 

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_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)
 

Constructor & Destructor Documentation

◆ CIBStaggeredStokesSolver() [1/2]

IBAMR::CIBStaggeredStokesSolver::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 
)

◆ ~CIBStaggeredStokesSolver()

IBAMR::CIBStaggeredStokesSolver::~CIBStaggeredStokesSolver ( )

◆ CIBStaggeredStokesSolver() [2/2]

IBAMR::CIBStaggeredStokesSolver::CIBStaggeredStokesSolver ( const CIBStaggeredStokesSolver from)
privatedelete
Note
This constructor is not implemented and should not be used.
Parameters
fromThe value to copy to this object.

Member Function Documentation

◆ initializeSolverState()

virtual 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.

◆ deallocateSolverState()

virtual void IBAMR::CIBStaggeredStokesSolver::deallocateSolverState ( )
overridevirtual

Deallocate the solver when hierarchy changes.

Reimplemented from IBTK::GeneralSolver.

◆ solveSystem()

virtual bool IBAMR::CIBStaggeredStokesSolver::solveSystem ( SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  x,
SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  b 
)
overridevirtual
Returns
true if the solver converged to the specified tolerances, false otherwise.

Implements IBTK::GeneralSolver.

◆ setVelocityPoissonSpecifications()

virtual void IBAMR::CIBStaggeredStokesSolver::setVelocityPoissonSpecifications ( const SAMRAI::solv::PoissonSpecifications u_problem_coefs)
overridevirtual

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ setPhysicalBcCoefs()

virtual void IBAMR::CIBStaggeredStokesSolver::setPhysicalBcCoefs ( const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &  u_bc_coefs,
SAMRAI::solv::RobinBcCoefStrategy< NDIM > *  p_bc_coef 
)
overridevirtual
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_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.

◆ setPhysicalBoundaryHelper()

virtual void IBAMR::CIBStaggeredStokesSolver::setPhysicalBoundaryHelper ( SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelper bc_helper)
overridevirtual

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ setSolutionTime()

virtual void IBAMR::CIBStaggeredStokesSolver::setSolutionTime ( double  solution_time)
overridevirtual

Reimplemented from IBTK::GeneralSolver.

◆ setTimeInterval()

virtual void IBAMR::CIBStaggeredStokesSolver::setTimeInterval ( double  current_time,
double  new_time 
)
overridevirtual

Reimplemented from IBTK::GeneralSolver.

◆ getSaddlePointSolver()

SAMRAI::tbox::Pointer<IBAMR::CIBSaddlePointSolver> IBAMR::CIBStaggeredStokesSolver::getSaddlePointSolver ( ) const

◆ operator=()

CIBStaggeredStokesSolver& IBAMR::CIBStaggeredStokesSolver::operator= ( const CIBStaggeredStokesSolver that)
privatedelete
Note
This operator is not implemented and should not be used.
Parameters
thatThe value to assign to this object.
Returns
A reference to this object.

◆ setComponentsHaveNullSpace()

virtual void IBAMR::StaggeredStokesSolver::setComponentsHaveNullSpace ( const bool  has_velocity_nullspace,
const bool  has_pressure_nullspace 
)
virtualinherited

◆ 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

◆ getSolutionTime()

virtual double IBTK::GeneralSolver::getSolutionTime ( ) const
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

◆ 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_cib_strategy

SAMRAI::tbox::Pointer<CIBStrategy> IBAMR::CIBStaggeredStokesSolver::d_cib_strategy
private

◆ d_num_rigid_parts

const unsigned int IBAMR::CIBStaggeredStokesSolver::d_num_rigid_parts
private

◆ d_sp_solver

SAMRAI::tbox::Pointer<IBAMR::CIBSaddlePointSolver> IBAMR::CIBStaggeredStokesSolver::d_sp_solver
private

◆ d_wide_u_var

SAMRAI::tbox::Pointer<SAMRAI::pdat::SideVariable<NDIM, double> > IBAMR::CIBStaggeredStokesSolver::d_wide_u_var
private

◆ d_wide_f_var

SAMRAI::tbox::Pointer<SAMRAI::pdat::SideVariable<NDIM, double> > IBAMR::CIBStaggeredStokesSolver::d_wide_f_var
private

◆ d_wide_ctx

SAMRAI::tbox::Pointer<SAMRAI::hier::VariableContext> IBAMR::CIBStaggeredStokesSolver::d_wide_ctx
private

◆ d_wide_u_idx

int IBAMR::CIBStaggeredStokesSolver::d_wide_u_idx = IBTK::invalid_index
private

◆ d_wide_f_idx

int IBAMR::CIBStaggeredStokesSolver::d_wide_f_idx = IBTK::invalid_index
private

◆ d_x_wide

SAMRAI::tbox::Pointer<SAMRAI::solv::SAMRAIVectorReal<NDIM, double> > IBAMR::CIBStaggeredStokesSolver::d_x_wide
private

◆ d_b_wide

SAMRAI::tbox::Pointer<SAMRAI::solv::SAMRAIVectorReal<NDIM, double> > IBAMR::CIBStaggeredStokesSolver::d_b_wide
private

◆ d_is_initialized

bool IBAMR::CIBStaggeredStokesSolver::d_is_initialized = false
private

◆ d_reinitializing_solver

bool IBAMR::CIBStaggeredStokesSolver::d_reinitializing_solver = false
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_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: