IBAMR  IBAMR version 0.19.
Public Member Functions | List of all members
IBAMR::INSStaggeredStochasticForcing Class Reference

Class INSStaggeredStochasticForcing provides an interface for specifying a stochastic forcing term for a staggered-grid incompressible Navier-Stokes solver.

#include <ibamr/INSStaggeredStochasticForcing.h>

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

Public Member Functions

 INSStaggeredStochasticForcing (std::string object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, const INSStaggeredHierarchyIntegrator *fluid_solver)
 This constructor creates Variable and VariableContext objects for storing the stochastic stresses at the centers and nodes of the Cartesian grid. More...
 
 ~INSStaggeredStochasticForcing ()=default
 Empty destructor. More...
 

Methods to set patch data.

std::string d_object_name
 
const INSStaggeredHierarchyIntegrator *const d_fluid_solver
 
StochasticStressTensorType d_stress_tensor_type = UNCORRELATED
 
double d_std = std::numeric_limits<double>::quiet_NaN()
 
int d_num_rand_vals = 0
 
std::vector< SAMRAI::tbox::Array< double > > d_weights
 
double d_velocity_bc_scaling
 
double d_traction_bc_scaling = 0.0
 
SAMRAI::tbox::Pointer< SAMRAI::hier::VariableContextd_context
 
SAMRAI::tbox::Pointer< SAMRAI::pdat::CellVariable< NDIM, double > > d_W_cc_var
 
int d_W_cc_idx = IBTK::invalid_index
 
std::vector< intd_W_cc_idxs
 
bool isTimeDependent () const override
 Indicates whether the concrete INSStaggeredStochasticForcing object is time-dependent. More...
 
void setDataOnPatchHierarchy (const int data_idx, SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > var, SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, const double data_time, const bool initial_time=false, const int coarsest_ln=IBTK::invalid_level_number, const int finest_ln=IBTK::invalid_level_number) override
 Evaluate the function on the patch interiors on the specified levels of the patch hierarchy. More...
 
void setDataOnPatch (const int data_idx, SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > var, SAMRAI::tbox::Pointer< SAMRAI::hier::Patch< NDIM > > patch, const double data_time, const bool initial_time=false, SAMRAI::tbox::Pointer< SAMRAI::hier::PatchLevel< NDIM > > patch_level=SAMRAI::tbox::Pointer< SAMRAI::hier::PatchLevel< NDIM > >(nullptr)) override
 Evaluate the function on the patch interior. More...
 
 INSStaggeredStochasticForcing ()=delete
 Default constructor. More...
 
 INSStaggeredStochasticForcing (const INSStaggeredStochasticForcing &from)=delete
 Copy constructor. More...
 
INSStaggeredStochasticForcingoperator= (const INSStaggeredStochasticForcing &that)=delete
 Assignment operator. More...
 

Constructor & Destructor Documentation

◆ INSStaggeredStochasticForcing() [1/3]

IBAMR::INSStaggeredStochasticForcing::INSStaggeredStochasticForcing ( std::string  object_name,
SAMRAI::tbox::Pointer< SAMRAI::tbox::Database input_db,
const INSStaggeredHierarchyIntegrator fluid_solver 
)

◆ ~INSStaggeredStochasticForcing()

IBAMR::INSStaggeredStochasticForcing::~INSStaggeredStochasticForcing ( )
default

◆ INSStaggeredStochasticForcing() [2/3]

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

◆ INSStaggeredStochasticForcing() [3/3]

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

Member Function Documentation

◆ isTimeDependent()

bool IBAMR::INSStaggeredStochasticForcing::isTimeDependent ( ) const
overridevirtual

◆ setDataOnPatchHierarchy()

void IBAMR::INSStaggeredStochasticForcing::setDataOnPatchHierarchy ( const int  data_idx,
SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > >  var,
SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > >  hierarchy,
const double  data_time,
const bool  initial_time = false,
const int  coarsest_ln = IBTK::invalid_level_number,
const int  finest_ln = IBTK::invalid_level_number 
)
overridevirtual

Reimplemented from IBTK::CartGridFunction.

◆ setDataOnPatch()

void IBAMR::INSStaggeredStochasticForcing::setDataOnPatch ( const int  data_idx,
SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > >  var,
SAMRAI::tbox::Pointer< SAMRAI::hier::Patch< NDIM > >  patch,
const double  data_time,
const bool  initial_time = false,
SAMRAI::tbox::Pointer< SAMRAI::hier::PatchLevel< NDIM > >  patch_level = SAMRAI::tbox::PointerSAMRAI::hier::PatchLevel< NDIM > >(nullptr) 
)
overridevirtual

◆ operator=()

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

◆ setDataOnPatchLevel()

virtual void IBTK::CartGridFunction::setDataOnPatchLevel ( int  data_idx,
SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > >  var,
SAMRAI::tbox::Pointer< SAMRAI::hier::PatchLevel< NDIM > >  patch_level,
double  data_time,
bool  initial_time = false 
)
virtualinherited

Member Data Documentation

◆ d_object_name

std::string IBAMR::INSStaggeredStochasticForcing::d_object_name
protected

The object name is used for error/warning reporting.

◆ d_fluid_solver

const INSStaggeredHierarchyIntegrator* const IBAMR::INSStaggeredStochasticForcing::d_fluid_solver
private

Pointer to the fluid solver object that is using this stochastic force generator.

◆ d_stress_tensor_type

StochasticStressTensorType IBAMR::INSStaggeredStochasticForcing::d_stress_tensor_type = UNCORRELATED
private

Type of stress tensor (correlated or uncorrelated).

◆ d_std

double IBAMR::INSStaggeredStochasticForcing::d_std = std::numeric_limits<double>::quiet_NaN()
private

Weighting data.

◆ d_num_rand_vals

int IBAMR::INSStaggeredStochasticForcing::d_num_rand_vals = 0
private

◆ d_weights

std::vector<SAMRAI::tbox::Array<double> > IBAMR::INSStaggeredStochasticForcing::d_weights
private

◆ d_velocity_bc_scaling

double IBAMR::INSStaggeredStochasticForcing::d_velocity_bc_scaling
private

Boundary condition scalings.

◆ d_traction_bc_scaling

double IBAMR::INSStaggeredStochasticForcing::d_traction_bc_scaling = 0.0
private

◆ d_context

SAMRAI::tbox::Pointer<SAMRAI::hier::VariableContext> IBAMR::INSStaggeredStochasticForcing::d_context
private

VariableContext and Variable objects for storing the components of the stochastic stresses.

◆ d_W_cc_var

SAMRAI::tbox::Pointer<SAMRAI::pdat::CellVariable<NDIM, double> > IBAMR::INSStaggeredStochasticForcing::d_W_cc_var
private

◆ d_W_cc_idx

int IBAMR::INSStaggeredStochasticForcing::d_W_cc_idx = IBTK::invalid_index
private

◆ d_W_cc_idxs

std::vector<int> IBAMR::INSStaggeredStochasticForcing::d_W_cc_idxs
private

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