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

Class PETScKrylovStaggeredStokesSolver is an extension of class PETScKrylovLinearSolver that provides an implementation of the StaggeredStokesSolver interface.

#include <ibamr/PETScKrylovStaggeredStokesSolver.h>

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

Public Member Functions

 PETScKrylovStaggeredStokesSolver (const std::string &object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, const std::string &default_options_prefix)
 Constructor. More...
 
 ~PETScKrylovStaggeredStokesSolver ()=default
 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...
 
void setHierarchyMathOps (SAMRAI::tbox::Pointer< HierarchyMathOps > hier_math_ops) override
 Set the HierarchyMathOps object used by the solver. 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 setComponentsHaveNullSpace (const bool has_velocity_nullspace, const bool has_pressure_nullspace) override
 Set if velocity and pressure have nullspace. 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...
 
General-purpose solver functionality.
void setHomogeneousBc (bool homogeneous_bc) override
 Set whether the solver should use homogeneous boundary conditions. More...
 
void setSolutionTime (double solution_time) override
 Set the time at which the solution is to be evaluated. More...
 
void setTimeInterval (double current_time, double new_time) override
 Set the current time interval. More...
 
Functions to access the underlying PETSc objects.
const KSP & getPETScKSP () const
 Get the PETSc KSP object. More...
 
General-purpose solver functionality.
void setHomogeneousBc (bool homogeneous_bc) override
 Set whether the solver should use homogeneous boundary conditions. More...
 
void setSolutionTime (double solution_time) override
 Set the time at which the solution is to be evaluated. More...
 
void setTimeInterval (double current_time, double new_time) override
 Set the current time interval. More...
 
Functions to access the underlying PETSc objects.
const KSP & getPETScKSP () const
 Get the PETSc KSP object. More...
 
General-purpose solver functionality.
void setHomogeneousBc (bool homogeneous_bc) override
 Set whether the solver should use homogeneous boundary conditions. More...
 
void setSolutionTime (double solution_time) override
 Set the time at which the solution is to be evaluated. More...
 
void setTimeInterval (double current_time, double new_time) override
 Set the current time interval. More...
 
Functions to access the underlying PETSc objects.
const KSP & getPETScKSP () const
 Get the PETSc KSP object. More...
 
General-purpose solver functionality.
void setHomogeneousBc (bool homogeneous_bc) override
 Set whether the solver should use homogeneous boundary conditions. More...
 
void setSolutionTime (double solution_time) override
 Set the time at which the solution is to be evaluated. More...
 
void setTimeInterval (double current_time, double new_time) override
 Set the current time interval. More...
 

Static Public Member Functions

static SAMRAI::tbox::Pointer< KrylovLinearSolverallocate_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 PETScKrylovLinearSolver. 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

 PETScKrylovStaggeredStokesSolver ()=delete
 Default constructor. More...
 
 PETScKrylovStaggeredStokesSolver (const PETScKrylovStaggeredStokesSolver &from)=delete
 Copy constructor. More...
 
PETScKrylovStaggeredStokesSolveroperator= (const PETScKrylovStaggeredStokesSolver &that)=delete
 Assignment operator. 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...
 
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)
 

Krylov solver functionality.

virtual SAMRAI::tbox::Pointer< LinearOperator > getOperator () const
 Retrieve the linear operator used when solving \(Ax=b\). More...
 
virtual SAMRAI::tbox::Pointer< LinearSolvergetPreconditioner () const
 Retrieve the preconditioner used by the Krylov subspace method when solving \(Ax=b\). More...
 
SAMRAI::tbox::Pointer< LinearOperator > d_A
 
SAMRAI::tbox::Pointer< LinearSolverd_pc_solver
 
SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > d_x
 
SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > d_b
 

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.

virtual void printClassData (std::ostream &stream) override
 Print class data to stream. More...
 
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
 

Krylov solver functionality.

void setOperator (SAMRAI::tbox::Pointer< LinearOperator > A) override
 Set the linear operator used when solving \(Ax=b\). More...
 
void setPreconditioner (SAMRAI::tbox::Pointer< LinearSolver > pc_solver=nullptr) override
 Set the preconditioner used by the Krylov subspace method when solving \(Ax=b\). 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 common_ctor ()
 Common routine used by all class constructors. More...
 
void resetWrappedKSP (KSP &petsc_ksp)
 Reset the KSP wrapped by this solver class. More...
 
void resetKSPOptions ()
 Reset the values of the convergence tolerances for the PETSc KSP object. More...
 
void resetKSPOperators ()
 Reset the KSP operators to correspond to the supplied LinearOperator. More...
 
void resetKSPPC ()
 Reset the KSP PC to correspond to the supplied preconditioner. More...
 
void resetMatNullSpace ()
 Reset the Mat nullspace object to correspond to the supplied nullspace basis vectors. More...
 
void deallocateNullSpaceData ()
 Destroy data allocated to describe nullspace. More...
 

Static functions for use by PETSc KSP and MatShell objects.

std::string d_ksp_type
 
bool d_reinitializing_solver = false
 
Vec d_petsc_x = nullptr
 
Vec d_petsc_b = nullptr
 
std::string d_options_prefix
 
MPI_Comm d_petsc_comm
 
KSP d_petsc_ksp = nullptr
 
Mat d_petsc_mat = nullptr
 
MatNullSpace d_petsc_nullsp = nullptr
 
bool d_managing_petsc_ksp = true
 
bool d_user_provided_mat = false
 
bool d_user_provided_pc = false
 
SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > d_nullspace_constant_vec
 
Vec d_petsc_nullspace_constant_vec = nullptr
 
std::vector< Vec > d_petsc_nullspace_basis_vecs
 
bool d_solver_has_attached_nullspace = false
 
static PetscErrorCode MatVecMult_SAMRAI (Mat A, Vec x, Vec y)
 Compute the matrix vector product \(y=Ax\). More...
 
static PetscErrorCode PCApply_SAMRAI (PC pc, Vec x, Vec y)
 Apply the preconditioner to x and store the result in y. More...
 

Constructor & Destructor Documentation

◆ PETScKrylovStaggeredStokesSolver() [1/3]

IBAMR::PETScKrylovStaggeredStokesSolver::PETScKrylovStaggeredStokesSolver ( const std::string &  object_name,
SAMRAI::tbox::Pointer< SAMRAI::tbox::Database input_db,
const std::string &  default_options_prefix 
)

◆ ~PETScKrylovStaggeredStokesSolver()

IBAMR::PETScKrylovStaggeredStokesSolver::~PETScKrylovStaggeredStokesSolver ( )
default

◆ PETScKrylovStaggeredStokesSolver() [2/3]

IBAMR::PETScKrylovStaggeredStokesSolver::PETScKrylovStaggeredStokesSolver ( )
privatedelete
Note
This constructor is not implemented and should not be used.

◆ PETScKrylovStaggeredStokesSolver() [3/3]

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

Member Function Documentation

◆ operator=()

PETScKrylovStaggeredStokesSolver& IBAMR::PETScKrylovStaggeredStokesSolver::operator= ( const PETScKrylovStaggeredStokesSolver 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.

◆ allocate_solver()

static SAMRAI::tbox::Pointer<KrylovLinearSolver> IBTK::PETScKrylovLinearSolver::allocate_solver ( const std::string &  object_name,
SAMRAI::tbox::Pointer< SAMRAI::tbox::Database input_db,
const std::string &  default_options_prefix 
)
inlinestaticinherited

◆ setKSPType()

void IBTK::PETScKrylovLinearSolver::setKSPType ( const std::string &  ksp_type)
inherited

◆ setOptionsPrefix()

void IBTK::PETScKrylovLinearSolver::setOptionsPrefix ( const std::string &  options_prefix)
inherited

◆ getPETScKSP()

const KSP& IBTK::PETScKrylovLinearSolver::getPETScKSP ( ) const
inherited

◆ setOperator()

void IBTK::PETScKrylovLinearSolver::setOperator ( SAMRAI::tbox::Pointer< LinearOperator A)
overridevirtualinherited

Reimplemented from IBTK::KrylovLinearSolver.

◆ setPreconditioner()

void IBTK::PETScKrylovLinearSolver::setPreconditioner ( SAMRAI::tbox::Pointer< LinearSolver pc_solver = nullptr)
overridevirtualinherited
Note
If the preconditioner is nullptr, no preconditioning is performed.

Reimplemented from IBTK::KrylovLinearSolver.

◆ setNullSpace()

void IBTK::PETScKrylovLinearSolver::setNullSpace ( bool  contains_constant_vec,
const std::vector< SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > > &  nullspace_basis_vecs = std::vector< SAMRAI::tbox::PointerSAMRAI::solv::SAMRAIVectorReal< NDIM, double > > >() 
)
overridevirtualinherited

Basis vectors must be orthogonal but are not required to be orthonormal. Basis vectors will be normalized automatically.

Reimplemented from IBTK::LinearSolver.

◆ solveSystem()

bool IBTK::PETScKrylovLinearSolver::solveSystem ( SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  x,
SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  b 
)
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.

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
The vector arguments for solveSystem() need not match those for initializeSolverState(). However, there must be 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
The solver need not 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.

◆ initializeSolverState()

void IBTK::PETScKrylovLinearSolver::initializeSolverState ( const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  x,
const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &  b 
)
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:

  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.

When linear operator or preconditioner objects have been registered with this class via setOperator() and setPreconditioner(), they are also initialized by this member function.

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
The vector arguments for solveSystem() need not match those for initializeSolverState(). However, there must be 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
It is safe to call initializeSolverState() when the state is already initialized. In this case, the solver state is first deallocated and then reinitialized.
See also
deallocateSolverState

Reimplemented from IBTK::GeneralSolver.

◆ deallocateSolverState()

void IBTK::PETScKrylovLinearSolver::deallocateSolverState ( )
overridevirtualinherited

When linear operator or preconditioner objects have been registered with this class via setOperator() and setPreconditioner(), they are also deallocated by this member function.

Note
It is safe to call deallocateSolverState() when the solver state is already deallocated.
See also
initializeSolverState

Reimplemented from IBTK::GeneralSolver.

◆ common_ctor()

void IBTK::PETScKrylovLinearSolver::common_ctor ( )
privateinherited

◆ resetWrappedKSP()

void IBTK::PETScKrylovLinearSolver::resetWrappedKSP ( KSP &  petsc_ksp)
privateinherited

◆ resetKSPOptions()

void IBTK::PETScKrylovLinearSolver::resetKSPOptions ( )
privateinherited

◆ resetKSPOperators()

void IBTK::PETScKrylovLinearSolver::resetKSPOperators ( )
privateinherited

◆ resetKSPPC()

void IBTK::PETScKrylovLinearSolver::resetKSPPC ( )
privateinherited

◆ resetMatNullSpace()

void IBTK::PETScKrylovLinearSolver::resetMatNullSpace ( )
privateinherited

◆ deallocateNullSpaceData()

void IBTK::PETScKrylovLinearSolver::deallocateNullSpaceData ( )
privateinherited

◆ MatVecMult_SAMRAI()

static PetscErrorCode IBTK::PETScKrylovLinearSolver::MatVecMult_SAMRAI ( Mat  A,
Vec  x,
Vec  y 
)
staticprivateinherited

◆ PCApply_SAMRAI()

static PetscErrorCode IBTK::PETScKrylovLinearSolver::PCApply_SAMRAI ( PC  pc,
Vec  x,
Vec  y 
)
staticprivateinherited

◆ setHierarchyMathOps()

void IBTK::KrylovLinearSolver::setHierarchyMathOps ( SAMRAI::tbox::Pointer< HierarchyMathOps hier_math_ops)
overridevirtualinherited

Reimplemented from IBTK::GeneralSolver.

◆ setHomogeneousBc()

void IBTK::KrylovLinearSolver::setHomogeneousBc ( bool  homogeneous_bc)
overridevirtualinherited

Reimplemented from IBTK::GeneralSolver.

◆ setSolutionTime()

void IBTK::KrylovLinearSolver::setSolutionTime ( double  solution_time)
overridevirtualinherited

Reimplemented from IBTK::GeneralSolver.

◆ setTimeInterval()

void IBTK::KrylovLinearSolver::setTimeInterval ( double  current_time,
double  new_time 
)
overridevirtualinherited

Reimplemented from IBTK::GeneralSolver.

◆ getOperator()

virtual SAMRAI::tbox::Pointer<LinearOperator> IBTK::KrylovLinearSolver::getOperator ( ) const
virtualinherited

◆ getPreconditioner()

virtual SAMRAI::tbox::Pointer<LinearSolver> IBTK::KrylovLinearSolver::getPreconditioner ( ) const
virtualinherited

◆ getNullSpaceContainsConstantVector()

virtual bool IBTK::LinearSolver::getNullSpaceContainsConstantVector ( ) const
virtualinherited

◆ getNullSpaceBasisVectors()

virtual const std::vector<SAMRAI::tbox::Pointer<SAMRAI::solv::SAMRAIVectorReal<NDIM, double> > >& IBTK::LinearSolver::getNullSpaceBasisVectors ( ) const
virtualinherited

◆ setInitialGuessNonzero()

virtual void IBTK::LinearSolver::setInitialGuessNonzero ( bool  initial_guess_nonzero = true)
virtualinherited

◆ getInitialGuessNonzero()

virtual bool IBTK::LinearSolver::getInitialGuessNonzero ( ) const
virtualinherited

Reimplemented in IBTK::PETScPCLSWrapper.

◆ printClassData()

virtual void IBTK::LinearSolver::printClassData ( std::ostream &  stream)
overridevirtualinherited

Reimplemented from IBTK::GeneralSolver.

◆ getName()

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

◆ getIsInitialized()

virtual bool IBTK::GeneralSolver::getIsInitialized ( ) const
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

◆ 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

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

◆ setVelocityPoissonSpecifications()

void IBAMR::KrylovLinearSolverStaggeredStokesSolverInterface::setVelocityPoissonSpecifications ( const SAMRAI::solv::PoissonSpecifications U_problem_coefs)
overridevirtualinherited

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ setComponentsHaveNullSpace()

void IBAMR::KrylovLinearSolverStaggeredStokesSolverInterface::setComponentsHaveNullSpace ( const bool  has_velocity_nullspace,
const bool  has_pressure_nullspace 
)
overridevirtualinherited

Reimplemented from IBAMR::StaggeredStokesSolver.

◆ setPhysicalBcCoefs()

void IBAMR::KrylovLinearSolverStaggeredStokesSolverInterface::setPhysicalBcCoefs ( const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &  U_bc_coefs,
SAMRAI::solv::RobinBcCoefStrategy< NDIM > *  P_bc_coef 
)
overridevirtualinherited
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::KrylovLinearSolverStaggeredStokesSolverInterface::setPhysicalBoundaryHelper ( SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelper bc_helper)
overridevirtualinherited

Reimplemented from IBAMR::StaggeredStokesSolver.

Member Data Documentation

◆ d_ksp_type

std::string IBTK::PETScKrylovLinearSolver::d_ksp_type
privateinherited

◆ d_reinitializing_solver

bool IBTK::PETScKrylovLinearSolver::d_reinitializing_solver = false
privateinherited

◆ d_petsc_x

Vec IBTK::PETScKrylovLinearSolver::d_petsc_x = nullptr
privateinherited

◆ d_petsc_b

Vec IBTK::PETScKrylovLinearSolver::d_petsc_b = nullptr
privateinherited

◆ d_options_prefix

std::string IBTK::PETScKrylovLinearSolver::d_options_prefix
privateinherited

◆ d_petsc_comm

MPI_Comm IBTK::PETScKrylovLinearSolver::d_petsc_comm
privateinherited

◆ d_petsc_ksp

KSP IBTK::PETScKrylovLinearSolver::d_petsc_ksp = nullptr
privateinherited

◆ d_petsc_mat

Mat IBTK::PETScKrylovLinearSolver::d_petsc_mat = nullptr
privateinherited

◆ d_petsc_nullsp

MatNullSpace IBTK::PETScKrylovLinearSolver::d_petsc_nullsp = nullptr
privateinherited

◆ d_managing_petsc_ksp

bool IBTK::PETScKrylovLinearSolver::d_managing_petsc_ksp = true
privateinherited

◆ d_user_provided_mat

bool IBTK::PETScKrylovLinearSolver::d_user_provided_mat = false
privateinherited

◆ d_user_provided_pc

bool IBTK::PETScKrylovLinearSolver::d_user_provided_pc = false
privateinherited

◆ d_nullspace_constant_vec

SAMRAI::tbox::Pointer<SAMRAI::solv::SAMRAIVectorReal<NDIM, double> > IBTK::PETScKrylovLinearSolver::d_nullspace_constant_vec
privateinherited

◆ d_petsc_nullspace_constant_vec

Vec IBTK::PETScKrylovLinearSolver::d_petsc_nullspace_constant_vec = nullptr
privateinherited

◆ d_petsc_nullspace_basis_vecs

std::vector<Vec> IBTK::PETScKrylovLinearSolver::d_petsc_nullspace_basis_vecs
privateinherited

◆ d_solver_has_attached_nullspace

bool IBTK::PETScKrylovLinearSolver::d_solver_has_attached_nullspace = false
privateinherited

◆ d_A

SAMRAI::tbox::Pointer<LinearOperator> IBTK::KrylovLinearSolver::d_A
protectedinherited

◆ d_pc_solver

SAMRAI::tbox::Pointer<LinearSolver> IBTK::KrylovLinearSolver::d_pc_solver
protectedinherited

◆ d_x

SAMRAI::tbox::Pointer<SAMRAI::solv::SAMRAIVectorReal<NDIM, double> > IBTK::KrylovLinearSolver::d_x
protectedinherited

◆ d_b

SAMRAI::tbox::Pointer<SAMRAI::solv::SAMRAIVectorReal<NDIM, double> > IBTK::KrylovLinearSolver::d_b
protectedinherited

◆ d_initial_guess_nonzero

bool IBTK::LinearSolver::d_initial_guess_nonzero = true
protectedinherited

◆ d_nullspace_contains_constant_vec

bool IBTK::LinearSolver::d_nullspace_contains_constant_vec = false
protectedinherited

◆ d_nullspace_basis_vecs

std::vector<SAMRAI::tbox::Pointer<SAMRAI::solv::SAMRAIVectorReal<NDIM, double> > > IBTK::LinearSolver::d_nullspace_basis_vecs
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

◆ 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

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