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

Class INSVCStaggeredConservativeMassMomentumSSPRKIntegrator is a derived class that integrates the staggered density field. More...

#include <ibamr/INSVCStaggeredConservativeMassMomentumSSPRKIntegrator.h>

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

Public Member Functions

 INSVCStaggeredConservativeMassMomentumSSPRKIntegrator (std::string object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db)
 Class constructor. More...
 
 ~INSVCStaggeredConservativeMassMomentumSSPRKIntegrator ()=default
 Destructor. More...
 
void integrate (double dt) override
 Integrate density and momentum field. More...
 

Private Member Functions

 INSVCStaggeredConservativeMassMomentumSSPRKIntegrator ()=delete
 Default constructor. More...
 
 INSVCStaggeredConservativeMassMomentumSSPRKIntegrator (const INSVCStaggeredConservativeMassMomentumSSPRKIntegrator &from)=delete
 Copy constructor. More...
 
INSVCStaggeredConservativeMassMomentumSSPRKIntegratoroperator= (const INSVCStaggeredConservativeMassMomentumSSPRKIntegrator &that)=delete
 Assignment operator. More...
 

Private Attributes

int d_num_steps = 3
 

General operator functionality.

virtual void initializeSTSIntegrator (SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchHierarchy< NDIM > > base_hierarchy) override
 Compute hierarchy dependent data required for time integrating variables. More...
 
virtual void deallocateSTSIntegrator () override
 Remove all hierarchy dependent data allocated by initializeSTSIntegrator(). More...
 
void setSideCenteredVelocityBoundaryConditions (const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &u_sc_bc_coefs)
 
int getUpdatedSideCenteredDensityPatchDataIndex ()
 Get the newly constructed side-centered density patch data index. More...
 
void setMassDensitySourceTerm (const SAMRAI::tbox::Pointer< IBTK::CartGridFunction > S_fcn)
 Set an optional mass density source term. More...
 
std::string d_velocity_bdry_extrap_type = "CONSTANT"
 
std::vector< IBTK::HierarchyGhostCellInterpolation::InterpolationTransactionComponentd_v_transaction_comps
 
SAMRAI::tbox::Pointer< IBTK::HierarchyGhostCellInterpolationd_hier_v_bdry_fill
 
LimiterType d_velocity_convective_limiter = CUI
 
int d_velocity_limiter_gcw = 1
 
void computeAdvectionVelocity (std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > U_adv_data, const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > U_data, const SAMRAI::hier::IntVector< NDIM > &patch_lower, const SAMRAI::hier::IntVector< NDIM > &patch_upper, const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &side_boxes)
 Compute the advection velocity using simple averages. More...
 
void interpolateSideQuantity (std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > Q_half_data, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > U_adv_data, const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > Q_data, const SAMRAI::hier::IntVector< NDIM > &patch_lower, const SAMRAI::hier::IntVector< NDIM > &patch_upper, const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &side_boxes, const LimiterType &convective_limiter)
 Compute the interpolation of a quantity Q onto Q_half, faces of the velocity DOF centered control volumes. More...
 
void computeConvectiveDerivative (SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > N_data, std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > P_half_data, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > U_adv_data, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > R_half_data, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > U_half_data, const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &side_boxes, const double *const dx, const SAMRAI::tbox::Pointer< SAMRAI::hier::Patch< NDIM > > &patch)
 Compute div[rho_half*u_half*u_adv]. More...
 
void computeDensityUpdate (SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > R_data, const double &a0, const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > R0_data, const double &a1, const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > R1_data, const double &a2, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > U_adv_data, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > R_half_data, const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > S_data, const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &side_boxes, const double &dt, const double *const dx)
 Compute the density update rho = a0*rho^0 + a1*rho^1 + a2*dt*(-div[u_adv*rho_half]) + a2*dt*S. More...
 
void computeErrorOfMassConservationEquation (SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > E_data, const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > Rnew_data, const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > > Rold_data, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > U_adv_data, const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM > R_half_data, const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &side_boxes, const double &dt, const double *const dx)
 Compute the error of the mass conservation equation using the integrated density field pointwise. More...
 
void enforceDivergenceFreeConditionAtCoarseFineInterface (const int U_idx)
 Enforce divergence free condition at the coarse-fine interface to ensure conservation of mass. More...
 

General time stepping functionality.

void setDensityPatchDataIndex (int rho_idx)
 Set the current cell-centered density patch data index. More...
 
void setConvectiveDerivativePatchDataIndex (int N_idx)
 Set the new convective derivative patch data index. More...
 
void setDensityBoundaryConditions (const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &rho_sc_bc_coefs)
 Set the boundary condition object for the density. More...
 
int getUpdatedDensityPatchDataIndex ()
 Get the newly constructed density patch data index. More...
 
void setFluidVelocityPatchDataIndices (int V_old_idx, int V_current_idx, int V_new_idx)
 Set the patch data indices corresponding to the velocity at the previous time step to be used when computing the density update. More...
 
void setCycleNumber (int cycle_num)
 Set the cycle number currently being executed by the INS integrator. This will determine the rho advection velocity. More...
 
void setSolutionTime (double solution_time)
 Set solution time. More...
 
void setTimeInterval (double current_time, double new_time)
 Set the current time interval. More...
 
std::pair< double, doublegetTimeInterval () const
 Get the current time interval. More...
 
double getTimeStepSize () const
 Get the current time step size. More...
 
void setPreviousTimeStepSize (double dt_prev)
 Set the previous time step value between times n - 1 (old) and n (current). This is used during velocity extrapolation. More...
 
void setHierarchyMathOps (SAMRAI::tbox::Pointer< IBTK::HierarchyMathOps > hier_math_ops)
 Set the HierarchyMathOps object used by the operator. More...
 
SAMRAI::tbox::Pointer< IBTK::HierarchyMathOpsgetHierarchyMathOps () const
 Get the HierarchyMathOps object used by the operator. More...
 
std::string d_object_name
 
SAMRAI::tbox::Pointer< StaggeredStokesPhysicalBoundaryHelperd_bc_helper
 
std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > d_bc_coefs
 
std::string d_density_bdry_extrap_type = "CONSTANT"
 
std::vector< IBTK::HierarchyGhostCellInterpolation::InterpolationTransactionComponentd_rho_transaction_comps
 
SAMRAI::tbox::Pointer< IBTK::HierarchyGhostCellInterpolationd_hier_rho_bdry_fill
 
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
 
std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > d_u_bc_coefs
 
std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > d_rho_bc_coefs
 
SAMRAI::tbox::Pointer< SAMRAI::math::HierarchyFaceDataOpsReal< NDIM, double > > d_hier_fc_data_ops
 
SAMRAI::tbox::Pointer< SAMRAI::math::HierarchySideDataOpsReal< NDIM, double > > d_hier_sc_data_ops
 
SAMRAI::tbox::Pointer< SAMRAI::math::HierarchyCellDataOpsReal< NDIM, double > > d_hier_cc_data_ops
 
SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > d_V_var
 
int d_V_scratch_idx = IBTK::invalid_index
 
int d_V_old_idx = IBTK::invalid_index
 
int d_V_current_idx = IBTK::invalid_index
 
int d_V_new_idx = IBTK::invalid_index
 
int d_V_composite_idx = IBTK::invalid_index
 
SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > d_rho_var
 
int d_rho_current_idx = IBTK::invalid_index
 
int d_rho_scratch_idx = IBTK::invalid_index
 
int d_rho_new_idx = IBTK::invalid_index
 
int d_rho_composite_idx = IBTK::invalid_index
 
int d_N_idx = IBTK::invalid_index
 
SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > d_S_var
 
int d_S_scratch_idx = IBTK::invalid_index
 
SAMRAI::tbox::Pointer< IBTK::CartGridFunctiond_S_fcn
 
SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > d_E_var
 
int d_E_scratch_idx = IBTK::invalid_index
 
SAMRAI::tbox::Pointer< IBTK::HierarchyMathOpsd_hier_math_ops
 
bool d_hier_math_ops_external = false
 
bool d_is_initialized = false
 
bool d_enable_logging = false
 
LimiterType d_density_convective_limiter = CUI
 
int d_density_limiter_gcw = 1
 
TimeSteppingType d_density_time_stepping_type = FORWARD_EULER
 
int d_cycle_num = -1
 
double d_current_time = std::numeric_limits<double>::quiet_NaN()
 
double d_new_time = std::numeric_limits<double>::quiet_NaN()
 
double d_solution_time = std::numeric_limits<double>::quiet_NaN()
 
double d_dt = std::numeric_limits<double>::quiet_NaN()
 
double d_dt_prev = -1.0
 
std::vector< SAMRAI::hier::CoarseFineBoundary< NDIM > > d_cf_boundary
 

Detailed Description

\( \frac{\partial \rho}{\partial t} + \nabla \cdot (\rho u) = S(x,t) \)

and computes the conservative form of the convective operator \( \nabla \cdot (\rho u u)\).

This class implements the SSP-RK2 and SSP-RK3 time stepping schemes.

Class INSVCStaggeredConservativeMassMomentumSSPRKIntegrator computes the convective derivative of a side-centered velocity field using various bounded-limiters described by Patel and Natarajan.

A side-centered density update is provided by this class, which is used in the conservative discretization of the incompressible Navier-Stokes equation. There is an optional mass density source term \( S(x,t) \) that can be set to check the order of accuracy via manufactured solutions.

References Patel, JK. and Natarajan, G., A generic framework for design of interface capturing schemes for multi-fluid flows

Note
This class is specialized in that it computes a conservative discretization of the form \(N = \nabla \cdot (u \rho u)\), where the density \(\rho\) can vary in space and time. This operator is to be used in conjuction with the conservative form of the variable coefficient Navier-Stokes equations, which will produce better results for high density ratio flows.
See also
INSVCStaggeredHierarchyIntegrator

Constructor & Destructor Documentation

◆ INSVCStaggeredConservativeMassMomentumSSPRKIntegrator() [1/3]

IBAMR::INSVCStaggeredConservativeMassMomentumSSPRKIntegrator::INSVCStaggeredConservativeMassMomentumSSPRKIntegrator ( std::string  object_name,
SAMRAI::tbox::Pointer< SAMRAI::tbox::Database input_db 
)

◆ ~INSVCStaggeredConservativeMassMomentumSSPRKIntegrator()

IBAMR::INSVCStaggeredConservativeMassMomentumSSPRKIntegrator::~INSVCStaggeredConservativeMassMomentumSSPRKIntegrator ( )
default

◆ INSVCStaggeredConservativeMassMomentumSSPRKIntegrator() [2/3]

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

◆ INSVCStaggeredConservativeMassMomentumSSPRKIntegrator() [3/3]

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

Member Function Documentation

◆ integrate()

void IBAMR::INSVCStaggeredConservativeMassMomentumSSPRKIntegrator::integrate ( double  dt)
overridevirtual

◆ operator=()

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

◆ initializeSTSIntegrator()

virtual void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::initializeSTSIntegrator ( SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchHierarchy< NDIM > >  base_hierarchy)
overridevirtualinherited

◆ deallocateSTSIntegrator()

virtual void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::deallocateSTSIntegrator ( )
overridevirtualinherited
Note
It is safe to call deallocateSTSIntegrator() when the time integrator is already deallocated.
See also
initializeSTSIntegrator

Implements IBAMR::STSMassFluxIntegrator.

◆ setSideCenteredVelocityBoundaryConditions()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::setSideCenteredVelocityBoundaryConditions ( const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &  u_sc_bc_coefs)
inherited

◆ getUpdatedSideCenteredDensityPatchDataIndex()

int IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::getUpdatedSideCenteredDensityPatchDataIndex ( )
inherited
Note
This data is produced as a part of the apply() routine and should be used in the linear operator for the INSVC solver.

◆ setMassDensitySourceTerm()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::setMassDensitySourceTerm ( const SAMRAI::tbox::Pointer< IBTK::CartGridFunction S_fcn)
inherited

◆ computeAdvectionVelocity()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::computeAdvectionVelocity ( std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  U_adv_data,
const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  U_data,
const SAMRAI::hier::IntVector< NDIM > &  patch_lower,
const SAMRAI::hier::IntVector< NDIM > &  patch_upper,
const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &  side_boxes 
)
protectedinherited

◆ interpolateSideQuantity()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::interpolateSideQuantity ( std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  Q_half_data,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  U_adv_data,
const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  Q_data,
const SAMRAI::hier::IntVector< NDIM > &  patch_lower,
const SAMRAI::hier::IntVector< NDIM > &  patch_upper,
const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &  side_boxes,
const LimiterType convective_limiter 
)
protectedinherited

◆ computeConvectiveDerivative()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::computeConvectiveDerivative ( SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  N_data,
std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  P_half_data,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  U_adv_data,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  R_half_data,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  U_half_data,
const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &  side_boxes,
const double *const  dx,
const SAMRAI::tbox::Pointer< SAMRAI::hier::Patch< NDIM > > &  patch 
)
protectedinherited

◆ computeDensityUpdate()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::computeDensityUpdate ( SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  R_data,
const double a0,
const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  R0_data,
const double a1,
const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  R1_data,
const double a2,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  U_adv_data,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  R_half_data,
const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  S_data,
const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &  side_boxes,
const double dt,
const double *const  dx 
)
protectedinherited

◆ computeErrorOfMassConservationEquation()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::computeErrorOfMassConservationEquation ( SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  E_data,
const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  Rnew_data,
const SAMRAI::tbox::Pointer< SAMRAI::pdat::SideData< NDIM, double > >  Rold_data,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  U_adv_data,
const std::array< SAMRAI::tbox::Pointer< SAMRAI::pdat::FaceData< NDIM, double > >, NDIM >  R_half_data,
const std::array< SAMRAI::hier::Box< NDIM >, NDIM > &  side_boxes,
const double dt,
const double *const  dx 
)
protectedinherited

◆ enforceDivergenceFreeConditionAtCoarseFineInterface()

void IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::enforceDivergenceFreeConditionAtCoarseFineInterface ( const int  U_idx)
protectedinherited

◆ setDensityPatchDataIndex()

void IBAMR::STSMassFluxIntegrator::setDensityPatchDataIndex ( int  rho_idx)
inherited

◆ setConvectiveDerivativePatchDataIndex()

void IBAMR::STSMassFluxIntegrator::setConvectiveDerivativePatchDataIndex ( int  N_idx)
inherited

◆ setDensityBoundaryConditions()

void IBAMR::STSMassFluxIntegrator::setDensityBoundaryConditions ( const std::vector< SAMRAI::solv::RobinBcCoefStrategy< NDIM > * > &  rho_sc_bc_coefs)
inherited

◆ getUpdatedDensityPatchDataIndex()

int IBAMR::STSMassFluxIntegrator::getUpdatedDensityPatchDataIndex ( )
inherited

◆ setFluidVelocityPatchDataIndices()

void IBAMR::STSMassFluxIntegrator::setFluidVelocityPatchDataIndices ( int  V_old_idx,
int  V_current_idx,
int  V_new_idx 
)
inherited
Note
This velocities will be used to compute an approximation to velocities required for time integrator. For example, SSPRK updates V_old_idx = n-1, V_current_idx = n, V_new_idx = n+1,k (after an INS cycle). If V_old_idx or V_new_idx are not set, then they will degenerate to V_current automatically, for the very first simulation time step and cases where an INS cycle has not been executed, respectively.

◆ setCycleNumber()

void IBAMR::STSMassFluxIntegrator::setCycleNumber ( int  cycle_num)
inherited

◆ setSolutionTime()

void IBAMR::STSMassFluxIntegrator::setSolutionTime ( double  solution_time)
inherited

◆ setTimeInterval()

void IBAMR::STSMassFluxIntegrator::setTimeInterval ( double  current_time,
double  new_time 
)
inherited

◆ getTimeInterval()

std::pair<double, double> IBAMR::STSMassFluxIntegrator::getTimeInterval ( ) const
inherited

◆ getTimeStepSize()

double IBAMR::STSMassFluxIntegrator::getTimeStepSize ( ) const
inherited

◆ setPreviousTimeStepSize()

void IBAMR::STSMassFluxIntegrator::setPreviousTimeStepSize ( double  dt_prev)
inherited

◆ setHierarchyMathOps()

void IBAMR::STSMassFluxIntegrator::setHierarchyMathOps ( SAMRAI::tbox::Pointer< IBTK::HierarchyMathOps hier_math_ops)
inherited

◆ getHierarchyMathOps()

SAMRAI::tbox::Pointer<IBTK::HierarchyMathOps> IBAMR::STSMassFluxIntegrator::getHierarchyMathOps ( ) const
inherited

Member Data Documentation

◆ d_num_steps

int IBAMR::INSVCStaggeredConservativeMassMomentumSSPRKIntegrator::d_num_steps = 3
private

◆ d_velocity_bdry_extrap_type

std::string IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::d_velocity_bdry_extrap_type = "CONSTANT"
protectedinherited

◆ d_v_transaction_comps

std::vector<IBTK::HierarchyGhostCellInterpolation::InterpolationTransactionComponent> IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::d_v_transaction_comps
protectedinherited

◆ d_hier_v_bdry_fill

SAMRAI::tbox::Pointer<IBTK::HierarchyGhostCellInterpolation> IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::d_hier_v_bdry_fill
protectedinherited

◆ d_velocity_convective_limiter

LimiterType IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::d_velocity_convective_limiter = CUI
protectedinherited

◆ d_velocity_limiter_gcw

int IBAMR::INSVCStaggeredConservativeMassMomentumRKIntegrator::d_velocity_limiter_gcw = 1
protectedinherited

◆ d_object_name

std::string IBAMR::STSMassFluxIntegrator::d_object_name
protectedinherited

◆ d_bc_helper

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

◆ d_bc_coefs

std::vector<SAMRAI::solv::RobinBcCoefStrategy<NDIM>*> IBAMR::STSMassFluxIntegrator::d_bc_coefs
protectedinherited

◆ d_density_bdry_extrap_type

std::string IBAMR::STSMassFluxIntegrator::d_density_bdry_extrap_type = "CONSTANT"
protectedinherited

◆ d_rho_transaction_comps

std::vector<IBTK::HierarchyGhostCellInterpolation::InterpolationTransactionComponent> IBAMR::STSMassFluxIntegrator::d_rho_transaction_comps
protectedinherited

◆ d_hier_rho_bdry_fill

SAMRAI::tbox::Pointer<IBTK::HierarchyGhostCellInterpolation> IBAMR::STSMassFluxIntegrator::d_hier_rho_bdry_fill
protectedinherited

◆ d_hierarchy

SAMRAI::tbox::Pointer<SAMRAI::hier::PatchHierarchy<NDIM> > IBAMR::STSMassFluxIntegrator::d_hierarchy
protectedinherited

◆ d_coarsest_ln

int IBAMR::STSMassFluxIntegrator::d_coarsest_ln = IBTK::invalid_level_number
protectedinherited

◆ d_finest_ln

int IBAMR::STSMassFluxIntegrator::d_finest_ln = IBTK::invalid_level_number
protectedinherited

◆ d_u_bc_coefs

std::vector<SAMRAI::solv::RobinBcCoefStrategy<NDIM>*> IBAMR::STSMassFluxIntegrator::d_u_bc_coefs
protectedinherited

◆ d_rho_bc_coefs

std::vector<SAMRAI::solv::RobinBcCoefStrategy<NDIM>*> IBAMR::STSMassFluxIntegrator::d_rho_bc_coefs
protectedinherited

◆ d_hier_fc_data_ops

SAMRAI::tbox::Pointer<SAMRAI::math::HierarchyFaceDataOpsReal<NDIM, double> > IBAMR::STSMassFluxIntegrator::d_hier_fc_data_ops
protectedinherited

◆ d_hier_sc_data_ops

SAMRAI::tbox::Pointer<SAMRAI::math::HierarchySideDataOpsReal<NDIM, double> > IBAMR::STSMassFluxIntegrator::d_hier_sc_data_ops
protectedinherited

◆ d_hier_cc_data_ops

SAMRAI::tbox::Pointer<SAMRAI::math::HierarchyCellDataOpsReal<NDIM, double> > IBAMR::STSMassFluxIntegrator::d_hier_cc_data_ops
protectedinherited

◆ d_V_var

SAMRAI::tbox::Pointer<SAMRAI::hier::Variable<NDIM> > IBAMR::STSMassFluxIntegrator::d_V_var
protectedinherited

◆ d_V_scratch_idx

int IBAMR::STSMassFluxIntegrator::d_V_scratch_idx = IBTK::invalid_index
protectedinherited

◆ d_V_old_idx

int IBAMR::STSMassFluxIntegrator::d_V_old_idx = IBTK::invalid_index
protectedinherited

◆ d_V_current_idx

int IBAMR::STSMassFluxIntegrator::d_V_current_idx = IBTK::invalid_index
protectedinherited

◆ d_V_new_idx

int IBAMR::STSMassFluxIntegrator::d_V_new_idx = IBTK::invalid_index
protectedinherited

◆ d_V_composite_idx

int IBAMR::STSMassFluxIntegrator::d_V_composite_idx = IBTK::invalid_index
protectedinherited

◆ d_rho_var

SAMRAI::tbox::Pointer<SAMRAI::hier::Variable<NDIM> > IBAMR::STSMassFluxIntegrator::d_rho_var
protectedinherited

◆ d_rho_current_idx

int IBAMR::STSMassFluxIntegrator::d_rho_current_idx = IBTK::invalid_index
protectedinherited

◆ d_rho_scratch_idx

int IBAMR::STSMassFluxIntegrator::d_rho_scratch_idx = IBTK::invalid_index
protectedinherited

◆ d_rho_new_idx

int IBAMR::STSMassFluxIntegrator::d_rho_new_idx = IBTK::invalid_index
protectedinherited

◆ d_rho_composite_idx

int IBAMR::STSMassFluxIntegrator::d_rho_composite_idx = IBTK::invalid_index
protectedinherited

◆ d_N_idx

int IBAMR::STSMassFluxIntegrator::d_N_idx = IBTK::invalid_index
protectedinherited

◆ d_S_var

SAMRAI::tbox::Pointer<SAMRAI::hier::Variable<NDIM> > IBAMR::STSMassFluxIntegrator::d_S_var
protectedinherited

◆ d_S_scratch_idx

int IBAMR::STSMassFluxIntegrator::d_S_scratch_idx = IBTK::invalid_index
protectedinherited

◆ d_S_fcn

SAMRAI::tbox::Pointer<IBTK::CartGridFunction> IBAMR::STSMassFluxIntegrator::d_S_fcn
protectedinherited

◆ d_E_var

SAMRAI::tbox::Pointer<SAMRAI::hier::Variable<NDIM> > IBAMR::STSMassFluxIntegrator::d_E_var
protectedinherited

◆ d_E_scratch_idx

int IBAMR::STSMassFluxIntegrator::d_E_scratch_idx = IBTK::invalid_index
protectedinherited

◆ d_hier_math_ops

SAMRAI::tbox::Pointer<IBTK::HierarchyMathOps> IBAMR::STSMassFluxIntegrator::d_hier_math_ops
protectedinherited

◆ d_hier_math_ops_external

bool IBAMR::STSMassFluxIntegrator::d_hier_math_ops_external = false
protectedinherited

◆ d_is_initialized

bool IBAMR::STSMassFluxIntegrator::d_is_initialized = false
protectedinherited

◆ d_enable_logging

bool IBAMR::STSMassFluxIntegrator::d_enable_logging = false
protectedinherited

◆ d_density_convective_limiter

LimiterType IBAMR::STSMassFluxIntegrator::d_density_convective_limiter = CUI
protectedinherited

◆ d_density_limiter_gcw

int IBAMR::STSMassFluxIntegrator::d_density_limiter_gcw = 1
protectedinherited

◆ d_density_time_stepping_type

TimeSteppingType IBAMR::STSMassFluxIntegrator::d_density_time_stepping_type = FORWARD_EULER
protectedinherited

◆ d_cycle_num

int IBAMR::STSMassFluxIntegrator::d_cycle_num = -1
protectedinherited

◆ d_current_time

double IBAMR::STSMassFluxIntegrator::d_current_time = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_new_time

double IBAMR::STSMassFluxIntegrator::d_new_time = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_solution_time

double IBAMR::STSMassFluxIntegrator::d_solution_time = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_dt

double IBAMR::STSMassFluxIntegrator::d_dt = std::numeric_limits<double>::quiet_NaN()
protectedinherited

◆ d_dt_prev

double IBAMR::STSMassFluxIntegrator::d_dt_prev = -1.0
protectedinherited

◆ d_cf_boundary

std::vector<SAMRAI::hier::CoarseFineBoundary<NDIM> > IBAMR::STSMassFluxIntegrator::d_cf_boundary
protectedinherited

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