MAIA bb96820c
Multiphysics at AIA
|
#include <fvcartesiansyseqnns.h>
Classes | |
struct | AdditionalVariables |
No additional variables are used in this SysEqn. More... | |
struct | ConservativeVariables |
Static indices for accessing conservative variables in nDim spatial dimensions. More... | |
struct | FluxVariables |
Static indices for accessing flux variables in this SysEqn identical to the conservative variables. More... | |
struct | PrimitiveVariables |
Static indices for accessing primitive variables in nDim spatial dimensions. More... | |
struct | SurfaceCoefficients |
Public Member Functions | |
FvSysEqnNS (const MInt solverId, const MInt noSpecies) | |
template<MInt scheme = AUSM> | |
void | Ausm (const MInt orientation, const MFloat upwindCoefficient, const MFloat A, const MFloat *const leftVars, const MFloat *const rightVars, const MFloat *const srfcCoeff, MFloat *const flux) |
void | Ausm_ (const MInt orientation, const MFloat upwindCoefficient, const MFloat A, const MFloat *const leftVars, const MFloat *const rightVars, const MFloat *const NotUsed(srfcCoeff), MFloat *const flux) |
void | AusmPlus_ (const MInt orientation, const MFloat upwindCoefficient, const MFloat A, const MFloat *const leftVars, const MFloat *const rightVars, const MFloat *const NotUsed(srfcCoeff), MFloat *const flux) |
void | Slau_ (const MInt orientation, const MFloat NotUsed(upwindCoefficient), const MFloat A, const MFloat *const leftVars, const MFloat *const rightVars, const MFloat *const NotUsed(srfcCoeff), MFloat *const flux) |
void | AusmBndryCorrection (const MInt orientation, const MFloat A, const MFloat *const leftVars, const MFloat *const rightVars, MFloat *const flux) |
void | AusmALECorrection (const MInt orientation, const MFloat A, MFloat *const flux, MFloat *const surfVars, const MFloat *const bndrySurfVars) |
template<MInt centralizeScheme> | |
void | centralizeSurfaceVariables (MFloat *const varL, MFloat *const varR, const MInt orientation, const MFloat levelFac) |
template<MInt stencil> | |
void | viscousFlux (const MInt orientation, const MFloat A, const MFloat *const vars0, const MFloat *const vars1, const MFloat *const slope0, const MFloat *const slope1, const MFloat *const srfcCoeff, const MFloat f0, const MFloat f1, MFloat *const flux) |
template<MInt stencil> | |
void | viscousFlux (const MInt orientation, const MFloat A, const MBool isBndry, const MFloat *const surfaceCoords, const MFloat *const coord0, const MFloat *const coord1, const MFloat *const cellVars0, const MFloat *const cellVars1, const MFloat *const vars0, const MFloat *const vars1, const MFloat *const slope0, const MFloat *const slope1, const MFloat f0, const MFloat f1, MFloat *const flux) |
void | viscousFluxFivePoint (const MInt orientation, const MFloat A, const MFloat *const vars0, const MFloat *const vars1, const MFloat *const slope0, const MFloat *const slope1, const MFloat *const NotUsed(srfcCoeff), const MFloat f0, const MFloat f1, MFloat *const flux) |
void | viscousFluxThreePoint (const MInt orientation, const MFloat A, const MBool isBndry, const MFloat *const surfaceCoords, const MFloat *const coord0, const MFloat *const coord1, const MFloat *const cellVars0, const MFloat *const cellVars1, const MFloat *const vars0, const MFloat *const vars1, const MFloat *const slope0, const MFloat *const slope1, const MFloat f0, const MFloat f1, MFloat *const flux) |
void | viscousFluxStabilized (const MInt orientation, const MFloat A, const MBool isBndry, const MFloat *const surfaceCoords, const MFloat *const coord0, const MFloat *const coord1, const MFloat *const cellVars0, const MFloat *const cellVars1, const MFloat *const vars0, const MFloat *const vars1, const MFloat *const slope0, const MFloat *const slope1, const MFloat f0, const MFloat f1, MFloat *const flux) |
Computes the viscous fluxes using a five-point stencil (less dissipative) blended with a compact stencil (increased stability). Short: (1-enhanceThreePointViscFluxFactor)*FIVE_POINT + enhanceThreePointViscFluxFactor*THREE_POINT Default for centralizeViscousFlux is 0.1 if not defined in property file. More... | |
template<MInt stencil> | |
void | wmViscousFluxCorrection (const MInt orientation, const MFloat A, const MFloat *const vars0, const MFloat *const vars1, const MFloat *const slope0, const MFloat *const slope1, const MFloat f0, const MFloat f1, MFloat *const flux, MFloat const mue_wm) |
void | wmViscousFluxCorrectionFivePoint (const MInt orientation, const MFloat A, const MFloat *const vars0, const MFloat *const vars1, const MFloat *const slope0, const MFloat *const slope1, const MFloat f0, const MFloat f1, MFloat *const flux, MFloat const mue_wm) |
void | computePrimitiveVariables (const MFloat *const cvarsCell, MFloat *const pvarsCell, const MFloat *const NotUsed(avarsCell)) |
void | computeConservativeVariables (const MFloat *const pvarsCell, MFloat *const cvarsCell, const MFloat *const NotUsed(avarsCell)) |
std::vector< std::vector< MFloat > > | conservativeSlopes (const MFloat *const pvarsCell, const MFloat *const cvarsCell, const MFloat *const avarsCell, const MFloat *const slopesCell) |
void | computeVolumeForces (const MInt, MFloat *, MFloat *, const MFloat, const MFloat *const, const MInt, const MInt *const, const MFloat *const, const MInt, MFloat) |
constexpr MFloat | speedOfSound (const MFloat density, const MFloat pressure) |
Speed of sound: a = sqrt(gamma * pressure / density) More... | |
constexpr MFloat | speedOfSoundSquared (const MFloat density, const MFloat pressure) |
speed of sound squared a^2 = gamma * pressure / density More... | |
constexpr MFloat | speedOfSound (const MFloat temperature) |
Speed of sound: a = sqrt(T) More... | |
constexpr MFloat | temperature_ES (const MFloat density, const MFloat pressure) |
Temperature: T = gamma * pressure / density (equation of state - ideal gas law) More... | |
constexpr MFloat | pressure_ES (const MFloat temperture, const MFloat density) |
pressure: p = rho * T / gamma (equation of state - ideal gas law) More... | |
constexpr MFloat | density_ES (const MFloat pressure, const MFloat temperature) |
density: rho = gamma * p / T (equation of state - ideal gas law) More... | |
constexpr MFloat | temperature_IR (const MFloat Ma) |
Temperature: T = 1 / (1 + (gamma - 1)/2 * Ma^2) (isentropic relationship) More... | |
constexpr MFloat | pressure_IR (const MFloat temperature) |
constexpr MFloat | pressure_IRit (const MFloat pressure, const MFloat massFlux) |
constexpr MFloat | density_IR (const MFloat temperature) |
density: rho = T^(1/(gamma -1 )) (isentropic relationship) More... | |
constexpr MFloat | density_IR_P (const MFloat pressure) |
density: rho = (p * gamma)^(1/gamma) (isentropic relationship) More... | |
constexpr MFloat | pressure (const MFloat density, const MFloat momentumDensitySquared, const MFloat energyDensity) |
constexpr MFloat | internalEnergy (const MFloat pressure, const MFloat density, const MFloat velocitySquared) |
constexpr MFloat | pressureEnergy (const MFloat pressure) |
constexpr MFloat | enthalpy (const MFloat pressure, const MFloat density) |
enthalpy from primitive variables More... | |
constexpr MFloat | entropy (const MFloat pressure, const MFloat density) |
entropy from primitive variables More... | |
constexpr MFloat | CroccoBusemann (const MFloat Ma, const MFloat x) |
Crocco-Busemann relation. More... | |
constexpr MFloat | vanDriest (const MFloat Ma) |
van-Driest Transformation (correspods to R*H) More... | |
constexpr MFloat | sutherlandLaw (const MFloat T) |
MFloat | computeTimeStepEulerMagnitude (const MFloat rho, const std::array< MFloat, nDim > u, const MFloat p, const MFloat C, const MFloat dx) |
constexpr MFloat | gamma_Ref () |
constexpr MFloat | cp_Ref () |
constexpr MFloat | cv_Ref () |
constexpr MFloat | p_Ref () |
constexpr MFloat | computeTimeStepDiffusion (const MFloat diffusion_coefficient, const MFloat C, const MFloat dx) |
Public Attributes | |
MFloat | m_Re0 = {} |
MFloat | m_muInfinity = {} |
ConservativeVariables * | CV = nullptr |
FluxVariables * | FV = nullptr |
PrimitiveVariables * | PV = nullptr |
AdditionalVariables * | AV = nullptr |
SurfaceCoefficients * | SC = nullptr |
Static Public Attributes | |
static constexpr MInt | m_noRansEquations = 0 |
static constexpr MInt | m_ransModel = NORANS |
static constexpr MBool | hasAV = false |
static constexpr MBool | hasSC = false |
static const MUint | index0 [nDim] |
static const MUint | index1 [nDim] |
Protected Member Functions | |
void | readProperties () |
Static Protected Member Functions | |
static MFloat | sgn (MFloat val) |
static constexpr std::array< MInt, nDim > | getArray012 () |
Protected Attributes | |
MUint | m_noSpecies |
MInt | m_solverId |
MFloat | m_gamma = 1.4 |
MFloat | m_gammaMinusOne = m_gamma - 1 |
MFloat | m_F1BGammaMinusOne = 1 / m_gammaMinusOne |
MFloat | m_FGammaBGammaMinusOne = m_gamma / m_gammaMinusOne |
MFloat | m_F1BGamma = 1 / m_gamma |
MFloat | m_Pr = 0.72 |
MFloat | m_F1BPr = 1 / m_Pr |
MFloat | m_referenceTemperature = {} |
MFloat | m_sutherlandPlusOne = {} |
MFloat | m_sutherlandConstant = {} |
MFloat | m_sutherlandPlusOneThermal = {} |
MFloat | m_sutherlandConstantThermal = {} |
MFloat | m_gFGMOrPr = {} |
MFloat | m_enhanceThreePointViscFluxFactor {} |
MFloat | m_centralizeSurfaceVariablesFactor = 0.0 |
Definition at line 31 of file fvcartesiansyseqnns.h.
FvSysEqnNS< nDim >::FvSysEqnNS | ( | const MInt | solverId, |
const MInt | noSpecies | ||
) |
Definition at line 10 of file fvcartesiansyseqnns.cpp.
|
inline |
Definition at line 39 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 436 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 647 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 623 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 497 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 665 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 1130 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 1110 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Computes the time-step from the stability condition for the Diffusion Eqt.
dt = C * dx^2 / diffusion_coefficient where C = (0, 1/4]
Definition at line 279 of file fvcartesiansyseqnns.h.
|
inline |
Computes the time-step from the CFL condition for the Euler-eqts as follows:
dt = C * dx / (||u|| + a)
Definition at line 253 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 153 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 1153 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
reference heat capacity at const. pressure as used in the non-dimensioanlization (i.e. at the reference condition with reference mixture/state/material)
Definition at line 266 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 233 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
reference heat capacity at const. volume as used in the non-dimensioanlization (i.e. at the reference condition with reference mixture/state/material)
Definition at line 270 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 179 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 200 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 203 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 223 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 228 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
reference heat capacity ratio used in the non-dimensioanlization (i.e. at the reference condition with reference mixture/state/material)
Definition at line 262 of file fvcartesiansyseqnns.h.
|
inlinestaticconstexprprotected |
|
inlineconstexpr |
energy from primitive variables: pv = (p, rho, u) iE = p / (gamma -1 ) + 0.5 * rho * ||u||^2
Definition at line 214 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
reference pressure as used in the non-dimensioanlization (i.e. at the reference condition with reference mixture/state/material)
Definition at line 274 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
pressure from conservative variables: cv = (rho, ||rho_u||^2, rhoE) p = (gamma - 1) * (rhoE - 0.5 ||rho_u||^2 / rho )
Definition at line 207 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 174 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
pressure: p = ( T ^(gamma/(gamma -1 ))) / gamma (isentropic relationship) NOTE: this is under consideration of the selected pressure non-dimensionalization!
Definition at line 188 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
pressure/density iteration based on mass-flux and p_old NOTE: see thesis of Ingolf Hoerschler
Definition at line 194 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
energy from primitive pressure variable (or delta p) pE = p / (gamma -1 )
Definition at line 220 of file fvcartesiansyseqnns.h.
|
protected |
|
inlinestaticprotected |
Definition at line 314 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 557 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 157 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 167 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 162 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Sutherland-law of viscosity mue = T^3/2 * (1+S/T_0)(T + S/T_0) with the default values S=110.4 k and T_0 = 273.15 K
Definition at line 246 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 170 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 184 of file fvcartesiansyseqnns.h.
|
inlineconstexpr |
Definition at line 238 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 86 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 73 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 727 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 988 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 863 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 125 of file fvcartesiansyseqnns.h.
|
inline |
Definition at line 807 of file fvcartesiansyseqnns.h.
AdditionalVariables* FvSysEqnNS< nDim >::AV = nullptr |
Definition at line 345 of file fvcartesiansyseqnns.h.
ConservativeVariables* FvSysEqnNS< nDim >::CV = nullptr |
Definition at line 342 of file fvcartesiansyseqnns.h.
FluxVariables* FvSysEqnNS< nDim >::FV = nullptr |
Definition at line 343 of file fvcartesiansyseqnns.h.
|
staticconstexpr |
Definition at line 340 of file fvcartesiansyseqnns.h.
|
staticconstexpr |
Definition at line 341 of file fvcartesiansyseqnns.h.
|
static |
Definition at line 350 of file fvcartesiansyseqnns.h.
|
static |
Definition at line 353 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 311 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 309 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 298 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 296 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 300 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 297 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 294 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 295 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 306 of file fvcartesiansyseqnns.h.
MFloat FvSysEqnNS< nDim >::m_muInfinity = {} |
Definition at line 330 of file fvcartesiansyseqnns.h.
|
staticconstexpr |
Definition at line 285 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 289 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 299 of file fvcartesiansyseqnns.h.
|
staticconstexpr |
Definition at line 286 of file fvcartesiansyseqnns.h.
MFloat FvSysEqnNS< nDim >::m_Re0 = {} |
Definition at line 329 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 301 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 291 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 303 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 305 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 302 of file fvcartesiansyseqnns.h.
|
protected |
Definition at line 304 of file fvcartesiansyseqnns.h.
PrimitiveVariables* FvSysEqnNS< nDim >::PV = nullptr |
Definition at line 344 of file fvcartesiansyseqnns.h.
SurfaceCoefficients* FvSysEqnNS< nDim >::SC = nullptr |
Definition at line 346 of file fvcartesiansyseqnns.h.