Standard 2d Navier-Stokes LBM stencil operator. More...
#include <LBMD2Q9Smag.h>
Public Types | |
enum | ICPredefined { GasAtRest, ConstantMacro, ConstantMicro } |
enum | BCPredefined { Symmetry, SlipWall, NoSlipWall, Inlet, Outlet, Pressure, SlidingWall } |
enum | GFMPredefined { GFMExtrapolation, GFMSlipWall, GFMNoSlipWall } |
enum | TurbulenceModel { laminar, LES_Smagorinsky } |
typedef base::vec_grid_data_type | vec_grid_data_type |
typedef base::grid_data_type | grid_data_type |
typedef base::MicroType | MicroType |
typedef base::MacroType | MacroType |
typedef GridData< MacroType, 2 > | macro_grid_data_type |
typedef base::SideName | SideName |
typedef base::point_type | point_type |
Public Member Functions | |
LBMD2Q9 () | |
virtual | ~LBMD2Q9 () |
virtual void | register_at (ControlDevice &Ctrl, const std::string &prefix) |
virtual void | SetupData (GridHierarchy *gh, const int &ghosts) |
virtual void | WriteInit () const |
virtual MacroType | MacroVariables (const MicroType &f) const |
virtual MicroType | Equilibrium (const MacroType &q) const |
virtual void | Collision (MicroType &f, const DataType dt) const |
virtual int | IncomingIndices (const int side, int indices[]) const |
virtual int | OutgoingIndices (const int side, int indices[]) const |
virtual void | ReverseStream (vec_grid_data_type &fvec, const BBox &bb, const int side) const |
virtual void | LocalStep (vec_grid_data_type &fvec, vec_grid_data_type &ovec, const BBox &bb, const double &dt) const |
virtual double | Step (vec_grid_data_type &fvec, vec_grid_data_type &ovec, vec_grid_data_type *Flux[], const double &t, const double &dt, const int &mpass) const |
virtual void | ICStandard (vec_grid_data_type &fvec, const int type, DataType *aux=0, const int naux=0, const int scaling=0) const |
virtual void | BCStandard (vec_grid_data_type &fvec, const BBox &bb, const int type, const int side, DataType *aux=0, const int naux=0, const int scaling=0) const |
virtual void | GFMBCStandard (vec_grid_data_type &fvec, const int type, const int &nc, const int *idx, const MicroType *f, const point_type *xc, const DataType *distance, const point_type *normal, DataType *aux=0, const int naux=0, const int scaling=0) const |
virtual void | Output (vec_grid_data_type &fvec, grid_data_type &workvec, const int cnt, const int skip_ghosts=1) const |
virtual void | Input (vec_grid_data_type &fvec, grid_data_type &workvec, const int cnt, const int skip_ghosts=1) const |
virtual int | Check (vec_grid_data_type &fvec, const BBox &bb, const double &time, const int verbose) const |
virtual int | NMethodOrder () const |
const DataType & | L0 () const |
const DataType & | T0 () const |
void | SetDensityScale (const DataType r0) |
void | SetVelocityScale (const DataType u0) |
void | SetSpeedUp (const DataType s0) |
virtual void | SetTimeScale (const DataType t0) |
const DataType & | DensityScale () const |
const DataType | VelocityScale () const |
const DataType & | SpeedUp () const |
DataType | LatticeViscosity (const DataType omega) const |
DataType | LatticeSpeedOfSound () const |
void | SetGas (DataType rho, DataType nu, DataType cs) |
virtual const DataType | Omega (const DataType dt) const |
const DataType | Omega_LES_Smagorinsky (const MicroType &f, const MicroType &feq, const MacroType &q, const DataType dt) const |
const int | TurbulenceType () const |
const DataType & | SmagorinskyConstant () |
const DataType & | GasDensity () const |
const DataType & | GasViscosity () const |
const DataType & | GasSpeedofSound () const |
const DataType | GasViscosity (const DataType omega, const DataType cs, const DataType dt) const |
void | SetGasProp (DataType g, DataType W, DataType R) |
virtual DataType | BasePressure () const |
virtual DataType | TempEquation (const DataType p) const |
Protected Attributes | |
DataType | cs2 |
DataType | cs22 |
DataType | cssq |
DataType | R0 |
DataType | U0 |
DataType | S0 |
DataType | rhop |
DataType | csp |
DataType | cs2p |
DataType | nup |
DataType | gp |
DataType | Wp |
DataType | Rp |
DataType | Cs_Smagorinsky |
DataType | turbulence |
int | method [1] |
int | mdx [9] |
int | mdy [9] |
Standard 2d Navier-Stokes LBM stencil operator.
Density distribution indexing used, 2D-BGK-operator
C5 C3 C4 \ | / C2--C0--C1 / | \ C8 C6 C7
typedef base::grid_data_type LBMD2Q9Smag< DataType >::grid_data_type |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
typedef GridData<MacroType,2> LBMD2Q9Smag< DataType >::macro_grid_data_type |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
typedef base::MacroType LBMD2Q9Smag< DataType >::MacroType |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
typedef base::MicroType LBMD2Q9Smag< DataType >::MicroType |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
typedef base::point_type LBMD2Q9Smag< DataType >::point_type |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
typedef base::SideName LBMD2Q9Smag< DataType >::SideName |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
typedef base::vec_grid_data_type LBMD2Q9Smag< DataType >::vec_grid_data_type |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
enum LBMD2Q9Smag::BCPredefined |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
enum LBMD2Q9Smag::GFMPredefined |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
enum LBMD2Q9Smag::ICPredefined |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
enum LBMD2Q9Smag::TurbulenceModel |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
virtual LBMD2Q9Smag< DataType >::~LBMD2Q9 | ( | ) | [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
virtual DataType LBMD2Q9Smag< DataType >::BasePressure | ( | ) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::cs2p, LBMD2Q9Smag< DataType >::gp, and LBMD2Q9Smag< DataType >::rhop.
Referenced by LBMD2Q9Smag< DataType >::Output(), and LBMD2Q9Smag< DataType >::WriteInit().
virtual void LBMD2Q9Smag< DataType >::BCStandard | ( | vec_grid_data_type & | fvec, | |
const BBox & | bb, | |||
const int | type, | |||
const int | side, | |||
DataType * | aux = 0 , |
|||
const int | naux = 0 , |
|||
const int | scaling = 0 | |||
) | const [inline, virtual] |
References SchemeBase< vector_type, dim >::Bottom, LBMD2Q9Smag< DataType >::Equilibrium(), SchemeBase< vector_type, dim >::idx(), LBMD2Q9Smag< DataType >::Inlet, SchemeBase< vector_type, dim >::Left, BBox::lower(), LBMD2Q9Smag< DataType >::MacroVariables(), LBMD2Q9Smag< DataType >::NoSlipWall, LBMD2Q9Smag< DataType >::Outlet, LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::Physical, LBMD2Q9Smag< DataType >::Pressure, LBMD2Q9Smag< DataType >::R0, SchemeBase< vector_type, dim >::Right, LBMD2Q9Smag< DataType >::S0, LBMD2Q9Smag< DataType >::SlidingWall, LBMD2Q9Smag< DataType >::SlipWall, BBox::stepsize(), LBMD2Q9Smag< DataType >::Symmetry, SchemeBase< vector_type, dim >::Top, LBMD2Q9Smag< DataType >::U0, and BBox::upper().
virtual int LBMD2Q9Smag< DataType >::Check | ( | vec_grid_data_type & | fvec, | |
const BBox & | bb, | |||
const double & | time, | |||
const int | verbose | |||
) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References grow(), SchemeBase< vector_type, dim >::idx(), BBox::lower(), LBMD2Q9Smag< DataType >::mdx, LBMD2Q9Smag< DataType >::mdy, AMRBase< vector_type, dim >::NGhosts(), LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::NMicroVar(), BBox::stepsize(), and BBox::upper().
virtual void LBMD2Q9Smag< DataType >::Collision | ( | MicroType & | f, | |
const DataType | dt | |||
) | const [inline, virtual] |
References LBMD2Q9Smag< DataType >::Equilibrium(), LBMD2Q9Smag< DataType >::laminar, LBMD2Q9Smag< DataType >::LES_Smagorinsky, LBMD2Q9Smag< DataType >::MacroVariables(), LBMD2Q9Smag< DataType >::Omega(), LBMD2Q9Smag< DataType >::Omega_LES_Smagorinsky(), and LBMD2Q9Smag< DataType >::turbulence.
Referenced by LBMD2Q9Smag< DataType >::LocalStep(), and LBMD2Q9Smag< DataType >::Step().
const DataType& LBMD2Q9Smag< DataType >::DensityScale | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::R0.
virtual MicroType LBMD2Q9Smag< DataType >::Equilibrium | ( | const MacroType & | q | ) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::cs2, LBMD2Q9Smag< DataType >::cs22, LBMD2Q9Smag< DataType >::cssq, LBMD2Q9Smag< DataType >::method, and LBMD2Q9Smag< DataType >::R0.
Referenced by LBMD2Q9Smag< DataType >::BCStandard(), LBMD2Q9Smag< DataType >::Collision(), LBMD2Q9Smag< DataType >::GFMBCStandard(), LBMD2Q9Smag< DataType >::ICStandard(), LBMD2Q9Smag< DataType >::Input(), and LBMD2Q9Smag< DataType >::Output().
const DataType& LBMD2Q9Smag< DataType >::GasDensity | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::rhop.
Referenced by LBMD2Q9Smag< DataType >::ICStandard().
const DataType& LBMD2Q9Smag< DataType >::GasSpeedofSound | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::csp.
Referenced by LBMD2Q9Smag< DataType >::Output(), and LBMD2Q9Smag< DataType >::SetGas().
const DataType LBMD2Q9Smag< DataType >::GasViscosity | ( | const DataType | omega, | |
const DataType | cs, | |||
const DataType | dt | |||
) | const [inline] |
References LBMD2Q9Smag< DataType >::S0.
const DataType& LBMD2Q9Smag< DataType >::GasViscosity | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::nup.
Referenced by LBMD2Q9Smag< DataType >::Output().
virtual void LBMD2Q9Smag< DataType >::GFMBCStandard | ( | vec_grid_data_type & | fvec, | |
const int | type, | |||
const int & | nc, | |||
const int * | idx, | |||
const MicroType * | f, | |||
const point_type * | xc, | |||
const DataType * | distance, | |||
const point_type * | normal, | |||
DataType * | aux = 0 , |
|||
const int | naux = 0 , |
|||
const int | scaling = 0 | |||
) | const [inline, virtual] |
References AMRBase< vector_type, dim >::Dim(), LBMD2Q9Smag< DataType >::Equilibrium(), LBMD2Q9Smag< DataType >::GFMExtrapolation, LBMD2Q9Smag< DataType >::GFMNoSlipWall, LBMD2Q9Smag< DataType >::GFMSlipWall, LBMD2Q9Smag< DataType >::MacroVariables(), LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::Physical, LBMD2Q9Smag< DataType >::S0, and LBMD2Q9Smag< DataType >::U0.
virtual void LBMD2Q9Smag< DataType >::ICStandard | ( | vec_grid_data_type & | fvec, | |
const int | type, | |||
DataType * | aux = 0 , |
|||
const int | naux = 0 , |
|||
const int | scaling = 0 | |||
) | const [inline, virtual] |
References LBMD2Q9Smag< DataType >::ConstantMacro, LBMD2Q9Smag< DataType >::ConstantMicro, LBMD2Q9Smag< DataType >::Equilibrium(), LBMD2Q9Smag< DataType >::GasAtRest, LBMD2Q9Smag< DataType >::GasDensity(), SchemeBase< vector_type, dim >::idx(), AMRBase< vector_type, dim >::NGhosts(), LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::NMacroVar(), LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::NMicroVar(), LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::Physical, LBMD2Q9Smag< DataType >::R0, LBMD2Q9Smag< DataType >::S0, and LBMD2Q9Smag< DataType >::U0.
virtual int LBMD2Q9Smag< DataType >::IncomingIndices | ( | const int | side, | |
int | indices[] | |||
) | const [inline, virtual] |
virtual void LBMD2Q9Smag< DataType >::Input | ( | vec_grid_data_type & | fvec, | |
grid_data_type & | workvec, | |||
const int | cnt, | |||
const int | skip_ghosts = 1 | |||
) | const [inline, virtual] |
const DataType& LBMD2Q9Smag< DataType >::L0 | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::LengthScale().
Referenced by LBMD2Q9Smag< DataType >::SetGas(), LBMD2Q9Smag< DataType >::SetTimeScale(), LBMD2Q9Smag< DataType >::SetupData(), LBMD2Q9Smag< DataType >::SetVelocityScale(), and LBMD2Q9Smag< DataType >::Step().
DataType LBMD2Q9Smag< DataType >::LatticeSpeedOfSound | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::cs2.
Referenced by LBMD2Q9Smag< DataType >::SetGas(), and LBMD2Q9Smag< DataType >::SetupData().
DataType LBMD2Q9Smag< DataType >::LatticeViscosity | ( | const DataType | omega | ) | const [inline] |
References LBMD2Q9Smag< DataType >::cs2.
LBMD2Q9Smag< DataType >::LBMD2Q9 | ( | ) | [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::cs2, LBMD2Q9Smag< DataType >::cs22, LBMD2Q9Smag< DataType >::cssq, LBMD2Q9Smag< DataType >::laminar, LBMD2Q9Smag< DataType >::mdx, LBMD2Q9Smag< DataType >::mdy, LBMD2Q9Smag< DataType >::method, and LBMD2Q9Smag< DataType >::turbulence.
virtual void LBMD2Q9Smag< DataType >::LocalStep | ( | vec_grid_data_type & | fvec, | |
vec_grid_data_type & | ovec, | |||
const BBox & | bb, | |||
const double & | dt | |||
) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::Collision(), SchemeBase< vector_type, dim >::idx(), comm_service::log(), BBox::lower(), LBMD2Q9Smag< DataType >::mdx, LBMD2Q9Smag< DataType >::mdy, LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::NMicroVar(), BBox::stepsize(), and BBox::upper().
virtual MacroType LBMD2Q9Smag< DataType >::MacroVariables | ( | const MicroType & | f | ) | const [inline, virtual] |
virtual int LBMD2Q9Smag< DataType >::NMethodOrder | ( | ) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
virtual const DataType LBMD2Q9Smag< DataType >::Omega | ( | const DataType | dt | ) | const [inline, virtual] |
Implements LBMBase< micro_type, macro_type, dim >.
References LBMD2Q9Smag< DataType >::cs2p, LBMD2Q9Smag< DataType >::nup, and LBMD2Q9Smag< DataType >::S0.
Referenced by LBMD2Q9Smag< DataType >::Collision(), and LBMD2Q9Smag< DataType >::Omega_LES_Smagorinsky().
virtual int LBMD2Q9Smag< DataType >::OutgoingIndices | ( | const int | side, | |
int | indices[] | |||
) | const [inline, virtual] |
virtual void LBMD2Q9Smag< DataType >::Output | ( | vec_grid_data_type & | fvec, | |
grid_data_type & | workvec, | |||
const int | cnt, | |||
const int | skip_ghosts = 1 | |||
) | const [inline, virtual] |
References LBMD2Q9Smag< DataType >::BasePressure(), LBMD2Q9Smag< DataType >::cs2, LBMD2Q9Smag< DataType >::Equilibrium(), LBMD2Q9Smag< DataType >::GasSpeedofSound(), LBMD2Q9Smag< DataType >::GasViscosity(), AMRBase< vector_type, dim >::GH(), SchemeBase< vector_type, dim >::idx(), LBMD2Q9Smag< DataType >::MacroVariables(), AMRBase< vector_type, dim >::NGhosts(), LBMD2Q9Smag< DataType >::Omega_LES_Smagorinsky(), LBMD2Q9Smag< DataType >::R0, LBMD2Q9Smag< DataType >::rhop, LBMD2Q9Smag< DataType >::S0, LBMD2Q9Smag< DataType >::TempEquation(), LBMD2Q9Smag< DataType >::U0, and GridHierarchy::worldStep().
virtual void LBMD2Q9Smag< DataType >::register_at | ( | ControlDevice & | Ctrl, | |
const std::string & | prefix | |||
) | [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::Cs_Smagorinsky, LBMD2Q9Smag< DataType >::csp, ControlDevice::getSubDevice(), LBMD2Q9Smag< DataType >::gp, AMRBase< vector_type, dim >::LocCtrl, LBMD2Q9Smag< DataType >::method, LBMD2Q9Smag< DataType >::nup, RegisterAt(), LBMD2Q9Smag< DataType >::rhop, LBMD2Q9Smag< DataType >::Rp, LBMD2Q9Smag< DataType >::S0, LBMD2Q9Smag< DataType >::turbulence, and LBMD2Q9Smag< DataType >::Wp.
virtual void LBMD2Q9Smag< DataType >::ReverseStream | ( | vec_grid_data_type & | fvec, | |
const BBox & | bb, | |||
const int | side | |||
) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References SchemeBase< vector_type, dim >::Bottom, SchemeBase< vector_type, dim >::idx(), SchemeBase< vector_type, dim >::Left, comm_service::log(), BBox::lower(), SchemeBase< vector_type, dim >::Right, BBox::stepsize(), SchemeBase< vector_type, dim >::Top, and BBox::upper().
void LBMD2Q9Smag< DataType >::SetDensityScale | ( | const DataType | r0 | ) | [inline] |
References LBMD2Q9Smag< DataType >::R0.
void LBMD2Q9Smag< DataType >::SetGas | ( | DataType | rho, | |
DataType | nu, | |||
DataType | cs | |||
) | [inline] |
References LBMD2Q9Smag< DataType >::cs2p, LBMD2Q9Smag< DataType >::csp, LBMD2Q9Smag< DataType >::GasSpeedofSound(), LBMD2Q9Smag< DataType >::L0(), LBMD2Q9Smag< DataType >::LatticeSpeedOfSound(), LBMD2Q9Smag< DataType >::nup, LBMD2Q9Smag< DataType >::rhop, and LBMD2Q9Smag< DataType >::SetTimeScale().
void LBMD2Q9Smag< DataType >::SetGasProp | ( | DataType | g, | |
DataType | W, | |||
DataType | R | |||
) | [inline] |
void LBMD2Q9Smag< DataType >::SetSpeedUp | ( | const DataType | s0 | ) | [inline] |
References LBMD2Q9Smag< DataType >::S0.
virtual void LBMD2Q9Smag< DataType >::SetTimeScale | ( | const DataType | t0 | ) | [inline, virtual] |
Reimplemented from LBMBase< micro_type, macro_type, dim >.
References LBMD2Q9Smag< DataType >::L0(), LBMD2Q9Smag< DataType >::S0, LBMD2Q9Smag< DataType >::T0(), LBMBase< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >::T0, and LBMD2Q9Smag< DataType >::U0.
Referenced by LBMD2Q9Smag< DataType >::SetGas(), and LBMD2Q9Smag< DataType >::SetupData().
virtual void LBMD2Q9Smag< DataType >::SetupData | ( | GridHierarchy * | gh, | |
const int & | ghosts | |||
) | [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::cs2p, LBMD2Q9Smag< DataType >::csp, LBMD2Q9Smag< DataType >::L0(), LBMD2Q9Smag< DataType >::LatticeSpeedOfSound(), LBMD2Q9Smag< DataType >::nup, LBMD2Q9Smag< DataType >::R0, LBMD2Q9Smag< DataType >::rhop, LBMD2Q9Smag< DataType >::SetTimeScale(), AMRBase< vector_type, dim >::SetupData(), LBMD2Q9Smag< DataType >::T0(), LBMD2Q9Smag< DataType >::U0, and LBMD2Q9Smag< DataType >::WriteInit().
void LBMD2Q9Smag< DataType >::SetVelocityScale | ( | const DataType | u0 | ) | [inline] |
const DataType& LBMD2Q9Smag< DataType >::SmagorinskyConstant | ( | ) | [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::Cs_Smagorinsky.
const DataType& LBMD2Q9Smag< DataType >::SpeedUp | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::S0.
virtual double LBMD2Q9Smag< DataType >::Step | ( | vec_grid_data_type & | fvec, | |
vec_grid_data_type & | ovec, | |||
vec_grid_data_type * | Flux[], | |||
const double & | t, | |||
const double & | dt, | |||
const int & | mpass | |||
) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::Collision(), AMRBase< vector_type, dim >::GH(), SchemeBase< vector_type, dim >::idx(), LBMD2Q9Smag< DataType >::L0(), LB_FACTOR, AMRBase< vector_type, dim >::NGhosts(), LBMD2Q9Smag< DataType >::T0(), and GridHierarchy::worldStep().
const DataType& LBMD2Q9Smag< DataType >::T0 | ( | ) | const [inline] |
virtual DataType LBMD2Q9Smag< DataType >::TempEquation | ( | const DataType | p | ) | const [inline, virtual] |
References LBMD2Q9Smag< DataType >::rhop, LBMD2Q9Smag< DataType >::Rp, and LBMD2Q9Smag< DataType >::Wp.
Referenced by LBMD2Q9Smag< DataType >::Output().
const int LBMD2Q9Smag< DataType >::TurbulenceType | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::turbulence.
const DataType LBMD2Q9Smag< DataType >::VelocityScale | ( | ) | const [inline] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::S0, and LBMD2Q9Smag< DataType >::U0.
virtual void LBMD2Q9Smag< DataType >::WriteInit | ( | ) | const [inline, virtual] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
References LBMD2Q9Smag< DataType >::BasePressure(), MY_PROC, LBMD2Q9Smag< DataType >::Rp, VizServer, and LBMD2Q9Smag< DataType >::Wp.
Referenced by LBMD2Q9Smag< DataType >::SetupData().
DataType LBMD2Q9Smag< DataType >::cs2 [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::Equilibrium(), LBMD2Q9Smag< DataType >::LatticeSpeedOfSound(), LBMD2Q9Smag< DataType >::LatticeViscosity(), LBMD2Q9Smag< DataType >::LBMD2Q9(), LBMD2Q9Smag< DataType >::Omega_LES_Smagorinsky(), and LBMD2Q9Smag< DataType >::Output().
DataType LBMD2Q9Smag< DataType >::cs22 [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::Equilibrium(), and LBMD2Q9Smag< DataType >::LBMD2Q9().
DataType LBMD2Q9Smag< DataType >::cs2p [protected] |
DataType LBMD2Q9Smag< DataType >::Cs_Smagorinsky [protected] |
DataType LBMD2Q9Smag< DataType >::csp [protected] |
DataType LBMD2Q9Smag< DataType >::cssq [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::Equilibrium(), and LBMD2Q9Smag< DataType >::LBMD2Q9().
DataType LBMD2Q9Smag< DataType >::gp [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::BasePressure(), LBMD2Q9Smag< DataType >::register_at(), and LBMD2Q9Smag< DataType >::SetGasProp().
int LBMD2Q9Smag< DataType >::mdx[9] [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::Check(), LBMD2Q9Smag< DataType >::LBMD2Q9(), and LBMD2Q9Smag< DataType >::LocalStep().
int LBMD2Q9Smag< DataType >::mdy[9] [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::Check(), LBMD2Q9Smag< DataType >::LBMD2Q9(), and LBMD2Q9Smag< DataType >::LocalStep().
int LBMD2Q9Smag< DataType >::method[1] [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::Equilibrium(), LBMD2Q9Smag< DataType >::LBMD2Q9(), and LBMD2Q9Smag< DataType >::register_at().
DataType LBMD2Q9Smag< DataType >::nup [protected] |
DataType LBMD2Q9Smag< DataType >::R0 [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::BCStandard(), LBMD2Q9Smag< DataType >::DensityScale(), LBMD2Q9Smag< DataType >::Equilibrium(), LBMD2Q9Smag< DataType >::ICStandard(), LBMD2Q9Smag< DataType >::Input(), LBMD2Q9Smag< DataType >::Omega_LES_Smagorinsky(), LBMD2Q9Smag< DataType >::Output(), LBMD2Q9Smag< DataType >::SetDensityScale(), and LBMD2Q9Smag< DataType >::SetupData().
DataType LBMD2Q9Smag< DataType >::rhop [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::BasePressure(), LBMD2Q9Smag< DataType >::GasDensity(), LBMD2Q9Smag< DataType >::Output(), LBMD2Q9Smag< DataType >::register_at(), LBMD2Q9Smag< DataType >::SetGas(), LBMD2Q9Smag< DataType >::SetupData(), and LBMD2Q9Smag< DataType >::TempEquation().
DataType LBMD2Q9Smag< DataType >::Rp [protected] |
DataType LBMD2Q9Smag< DataType >::S0 [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::BCStandard(), LBMD2Q9Smag< DataType >::GasViscosity(), LBMD2Q9Smag< DataType >::GFMBCStandard(), LBMD2Q9Smag< DataType >::ICStandard(), LBMD2Q9Smag< DataType >::Input(), LBMD2Q9Smag< DataType >::Omega(), LBMD2Q9Smag< DataType >::Omega_LES_Smagorinsky(), LBMD2Q9Smag< DataType >::Output(), LBMD2Q9Smag< DataType >::register_at(), LBMD2Q9Smag< DataType >::SetSpeedUp(), LBMD2Q9Smag< DataType >::SetTimeScale(), LBMD2Q9Smag< DataType >::SetVelocityScale(), LBMD2Q9Smag< DataType >::SpeedUp(), and LBMD2Q9Smag< DataType >::VelocityScale().
DataType LBMD2Q9Smag< DataType >::turbulence [protected] |
DataType LBMD2Q9Smag< DataType >::U0 [protected] |
Reimplemented from LBMD2Q9< Vector< DataType, 9 >, Vector< DataType, 3 >, 2 >.
Referenced by LBMD2Q9Smag< DataType >::BCStandard(), LBMD2Q9Smag< DataType >::GFMBCStandard(), LBMD2Q9Smag< DataType >::ICStandard(), LBMD2Q9Smag< DataType >::Input(), LBMD2Q9Smag< DataType >::Output(), LBMD2Q9Smag< DataType >::SetTimeScale(), LBMD2Q9Smag< DataType >::SetupData(), LBMD2Q9Smag< DataType >::SetVelocityScale(), and LBMD2Q9Smag< DataType >::VelocityScale().
DataType LBMD2Q9Smag< DataType >::Wp [protected] |