MAIA bb96820c
Multiphysics at AIA
|
#include <fvcartesianapesolver2d.h>
Public Member Functions | |
FvApeSolver2D (MInt, MInt, MBool *, maia::grid::Proxy< 2 > &gridProxy_, Geometry< 2 > &geometry_, const MPI_Comm comm) | |
void | Ausm () |
Dispatches the AUSM flux computation for different number of species. More... | |
MBool | maxResidual (MInt) |
Computes the global root-mean-square residual. The residual is defined as time derivative of conservative variables, RHS/cellVolume. This gives a residual independent of the time step. Similarly, the volume-weighting/volume-integrated RMS value results in a residual independent from the number of cells, thus smooth in time for dynamic mesh adaptation. mode 0 (default) : also write residual file mode 1 : pure debugging of the residual. More... | |
Public Member Functions inherited from FvCartesianSolverXD< 2, FvSysEqnNS< 2 > > | |
FvCartesianSolverXD ()=delete | |
FvCartesianSolverXD (MInt, MInt, const MBool *, maia::grid::Proxy< nDim_ > &gridProxy_, Geometry< nDim_ > &geometry_, const MPI_Comm comm) | |
~FvCartesianSolverXD () | |
FvSysEqnNS< 2 > | sysEqn () const |
FvSysEqnNS< 2 > & | sysEqn () |
MInt | a_noCells () const |
Returns the number of cells. More... | |
MInt | noInternalCells () const override |
Return the number of internal cells within this solver. More... | |
MBool | a_isGapCell (const MInt cellId) const |
Returns isGapCell of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isGapCell (const MInt cellId) |
Returns isGapCell of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_wasGapCell (const MInt cellId) |
Returns wasGapCell of the cell cellId . More... | |
MBool | a_isHalo (const MInt cellId) const |
Returns IsHalo of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isHalo (const MInt cellId) |
Returns IsHalo of the cell cellId . More... | |
MBool | a_isWindow (const MInt cellId) const |
Returns IsWindow of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isWindow (const MInt cellId) |
Returns IsWindow of the cell cellId . More... | |
MBool | a_isPeriodic (const MInt cellId) const |
Returns IsPeriodic of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isPeriodic (const MInt cellId) |
Returns IsPeriodic of the cell cellId . More... | |
MBool | a_isBndryCell (const MInt cellId) const override |
Returns isBndryCell of the cell cellId . More... | |
MBool | a_isInterface (const MInt cellId) const |
Returns isInterface of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isInterface (const MInt cellId) |
Returns isInterface of the cell cellId . More... | |
MBool | a_isBndryGhostCell (const MInt cellId) const |
Returns isBndryGhostCell of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isBndryGhostCell (const MInt cellId) |
Returns isBndryGhostCell of the cell cellId . More... | |
MBool | a_isWMImgCell (const MInt cellId) const |
Returns isWMImgCell of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isWMImgCell (const MInt cellId) |
Returns isWMImgCell of the cell cellId . More... | |
MBool | a_isSandpaperTripCell (const MInt cellId) const |
Returns isWMImgCell of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_isSandpaperTripCell (const MInt cellId) |
Returns isWMImgCell of the cell cellId . More... | |
maia::fv::cell::BitsetType & | a_properties (const MInt cellId) |
Returns properties of the cell cellId . More... | |
MFloat & | a_spongeFactor (const MInt cellId) |
Returns the spongeFactor of the cell cellId . More... | |
MFloat | a_spongeFactor (const MInt cellId) const |
Returns the spongeFactor of the cell cellId . More... | |
MFloat & | a_coordinate (const MInt cellId, const MInt dir) |
Returns the coordinate of the cell from the fvcellcollector cellId for dimension dir . More... | |
MFloat | a_coordinate (const MInt cellId, const MInt dir) const |
Returns the coordinate of the cell from the fvcellcollector cellId for dimension dir . More... | |
MInt & | a_level (const MInt cellId) |
Returns the level of the cell from the fvcellcollector cellId . More... | |
MInt | a_level (const MInt cellId) const |
Returns the level of the cell from the fvcellcollector cellId . More... | |
MFloat & | a_cellVolume (const MInt cellId) |
Returns the cell volume of the cell from the fvcellcollector cellId . More... | |
MFloat | a_cellVolume (const MInt cellId) const |
Returns the cell volume of the cell from the fvcellcollector cellId . More... | |
MFloat & | a_FcellVolume (const MInt cellId) override |
Returns the inverse cell volume of the cell from the fvcellcollector cellId . More... | |
MFloat | a_FcellVolume (const MInt cellId) const |
Returns the inverse cell volume of the cell from the fvcellcollector cellId . More... | |
MInt | a_cutCellLevel (const MInt cellId) const |
Returns the level for cutCells, this can either be the maxRefinementLevel or the level of the current cellId . More... | |
MBool | a_isInactive (const MInt cellId) const |
MBool | a_isActive (const MInt cellId) const |
MBool | a_isSplitCell (const MInt cellId) const |
MInt | a_noSplitCells () const |
MInt | a_noSplitChilds (const MInt sc) const |
MInt | a_splitChildId (const MInt sc, const MInt ssc) |
MInt | a_splitCellId (const MInt sc) const |
void | assertValidGridCellId (const MInt cellId) const |
Cecks wether the cell cellId is an actual grid-cell. More... | |
void | assertValidGridCellId (const MInt NotUsed(cellId)) const |
void | assertDeleteNeighbor (const MInt cellId, const MInt dir) const |
Checks wether the cell cellId has a valid neighbor in direction dir . More... | |
MBool | checkNeighborActive (const MInt cellId, const MInt dir) const |
Cecks wether the cell cellId has a valid neighbor in direction dir . More... | |
MFloat | c_coordinate (const MInt cellId, const MInt dir) const |
Returns the coordinate of the cell from the grid().tree() cellId for dimension dir . More... | |
MBool | c_isLeafCell (const MInt cellId) const |
MInt | c_level (const MInt cellId) const |
Returns the grid level of the cell cellId . More... | |
MInt | c_noChildren (const MInt cellId) const |
Returns the number of children of the cell cellId . More... | |
MLong | c_parentId (const MInt cellId) const |
Returns the grid parent id of the cell cellId . More... | |
MLong | c_globalId (const MInt cellId) const |
Returns the global grid id of the grid cell cellId . More... | |
MFloat | c_weight (const MInt cellId) const |
Returns the weight of the cell cellId . More... | |
MLong | c_childId (const MInt cellId, const MInt pos) const |
Returns the grid child id of the grid cell cellId at position pos . More... | |
MLong | c_neighborId (const MInt cellId, const MInt dir, const MBool assertNeighborState=true) const |
Returns the grid neighbor id of the grid cell cellId dir . More... | |
MFloat | c_cellLengthAtCell (const MInt cellId) const |
Returns the length of the cell for level . More... | |
MFloat | c_cellLengthAtLevel (const MInt level) const |
Returns the length of the cell for level . More... | |
MFloat | c_cellVolumeAtLevel (const MInt level) const |
Returns the grid Volume of the cell for level . More... | |
MBool | a_hasProperty (const MInt cellId, const Cell p) const |
Returns grid cell property p of the cell cellId . More... | |
maia::fv::cell::BitsetType::reference | a_hasProperty (const MInt cellId, const SolverCell p) |
Returns solver cell property p of the cell cellId . More... | |
MBool | a_hasProperty (const MInt cellId, const SolverCell p) const |
Returns solver cell property p of the cell cellId . More... | |
MBool | c_isToDelete (const MInt cellId) const |
Returns the delete of the cell cellId . More... | |
MInt | a_hasNeighbor (const MInt cellId, const MInt dir, const MBool assertNeighborState=true) const |
Returns noNeighborIds of the cell CellId for direction dir . More... | |
MFloat & | a_variable (const MInt cellId, const MInt varId) |
Returns conservative variable v of the cell cellId for variables varId . More... | |
MFloat | a_variable (const MInt cellId, const MInt varId) const |
Returns conservative variable v of the cell cellId for variables varId . More... | |
MFloat & | a_pvariable (const MInt cellId, const MInt varId) |
Returns primitive variable v of the cell cellId for variables varId . More... | |
MFloat | a_pvariable (const MInt cellId, const MInt varId) const |
Returns primitive variable v of the cell cellId for variables varId . More... | |
MFloat & | a_avariable (const MInt cellId, const MInt varId) |
Returns additional variable v of the cell cellId for variables varId . More... | |
MFloat | a_avariable (const MInt cellId, const MInt varId) const |
Returns additional variable v of the cell cellId for variables varId . More... | |
void | a_resetPropertiesSolver (const MInt cellId) |
Returns property p of the cell cellId . More... | |
void | a_copyPropertiesSolver (const MInt fromCellId, const MInt toCellId) |
Returns property p of the cell cellId . More... | |
MInt & | a_reconstructionNeighborId (const MInt cellId, const MInt nghbrNo) |
Returns reconstruction neighbor n of the cell cellId . More... | |
MInt | a_reconstructionNeighborId (const MInt cellId, const MInt nghbrNo) const |
Returns reconstruction neighbor n of the cell cellId . More... | |
MInt | a_reconstructionNeighborId (const MInt cellId) const |
Returns reconstruction data offset i of the cell cellId . More... | |
MInt & | a_reconstructionData (const MInt cellId) |
Returns reconstruction data offset i of the cell cellId . More... | |
MInt & | a_spongeBndryId (const MInt cellId, const MInt dir) |
Returns the spongeBndryId of the cell cellId for direction dir . More... | |
MInt | a_spongeBndryId (const MInt cellId, const MInt dir) const |
Returns the spongeBndryId of the cell cellId for direction dir . More... | |
MFloat & | a_spongeFactorStart (const MInt cellId) |
Returns the spongeFactorStart of the cell cellId . More... | |
MFloat | a_spongeFactorStart (const MInt cellId) const |
Returns the spongeFactorStart of the cell cellId . More... | |
MInt & | a_bndryId (const MInt cellId) |
Returns the bndryId of the cell cellId . More... | |
MInt | a_bndryId (const MInt cellId) const |
Returns the bndryId of the cell cellId . More... | |
MInt & | a_noReconstructionNeighbors (const MInt cellId) |
Returns the noRcnstrctnNghbrIds of the cell cellId . More... | |
MInt | a_noReconstructionNeighbors (const MInt cellId) const |
Returns the noRcnstrctnNghbrIds of the cell cellId . More... | |
MFloat & | a_tau (const MInt cellId, const MInt varId) |
Returns the tau of the cell cellId for variable varId . More... | |
MFloat | a_tau (const MInt cellId, const MInt varId) const |
Returns the tau of the cell cellId for variable varId . More... | |
MFloat & | a_restrictedRHS (const MInt cellId, const MInt varId) |
Returns the restrictedRHS of the cell cellId for variable varId . More... | |
MFloat | a_restrictedRHS (const MInt cellId, const MInt varId) const |
Returns the restrictedRHS of the cell cellId for variable varId . More... | |
MFloat & | a_restrictedVar (const MInt cellId, const MInt varId) |
Returns restricted variables of cell cellId for variable varId on level level . More... | |
MFloat | a_restrictedVar (const MInt cellId, const MInt varId) const |
Returns restricted variables of cell cellId for variable varId on level level . More... | |
MFloat & | a_reactionRate (const MInt cellId, const MInt reactionId) |
Returns the reactionRate of the cell cellId for variables varId . More... | |
MFloat | a_reactionRate (const MInt cellId, const MInt reactionId) const |
Returns the reactionRate of the cell cellId for variables varId . More... | |
MFloat & | a_reactionRateBackup (const MInt cellId, const MInt reactionId) |
Returns the reactionRateBackup of the cell cellId for variables varId . More... | |
MFloat | a_reactionRateBackup (const MInt cellId, const MInt reactionId) const |
Returns the reactionRateBackup of the cell cellId for variables varId . More... | |
MFloat & | a_psi (const MInt cellId) |
Returns psi of the cell cellId for variables varId . More... | |
MFloat | a_psi (const MInt cellId) const |
Returns psi of the cell cellId for variables varId . More... | |
MFloat & | a_speciesReactionRate (const MInt cellId, const MInt speciesIndex) |
MFloat | a_speciesReactionRate (const MInt cellId, const MInt speciesIndex) const |
MFloat & | a_implicitCoefficient (const MInt cellId, const MInt coefId) |
Returns the implicitCoefficient of cell cellId for coefficient coefId . More... | |
MFloat | a_implicitCoefficient (const MInt cellId, const MInt coefId) const |
Returns the implicitCoefficient of cell cellId for coefficient coefId . More... | |
MFloat & | a_dt1Variable (const MInt cellId, const MInt varId) |
Returns dt1Variables of the cell CellId variables varId . More... | |
MFloat | a_dt1Variable (const MInt cellId, const MInt varId) const |
Returns dt1Variables of the cell CellId variables varId . More... | |
MFloat & | a_dt2Variable (const MInt cellId, const MInt varId) |
Returns dt2Variables of the cell CellId variables varId . More... | |
MFloat | a_dt2Variable (const MInt cellId, const MInt varId) const |
Returns dt2Variables of the cell CellId variables varId . More... | |
MFloat & | a_oldVariable (const MInt cellId, const MInt varId) |
Returns oldVariablesv of the cell cellId variables varId . More... | |
MFloat | a_oldVariable (const MInt cellId, const MInt varId) const |
Returns oldVariables v of the cell cellId variables varId . More... | |
MFloat & | a_slope (const MInt cellId, MInt const varId, const MInt dir) override |
Returns the slope of the cell cellId for the variable varId in direction dir . More... | |
MFloat | a_slope (const MInt cellId, MInt const varId, const MInt dir) const |
Returns the slope of the cell cellId for the variable varId in direction dir . More... | |
MFloat & | a_storedSlope (const MInt cellId, MInt const varId, const MInt dir) |
Returns the stored slope of the cell cellId for the variable varId in direction dir . More... | |
MFloat | a_storedSlope (const MInt cellId, MInt const varId, const MInt dir) const |
Returns the stored slope of the cell cellId for the variable varId in direction dir . More... | |
MFloat & | a_rightHandSide (const MInt cellId, MInt const varId) |
Returns the right hand side of the cell cellId for the variable varId . More... | |
MFloat | a_rightHandSide (const MInt cellId, MInt const varId) const |
Returns the right hand side of the cell cellId for the variable varId . More... | |
MInt | a_noSurfaces () |
Returns the number of surfaces. More... | |
MInt & | a_surfaceBndryCndId (const MInt srfcId) |
Returns the boundary condition of surface srfcId . More... | |
MInt | a_surfaceBndryCndId (const MInt srfcId) const |
Returns the boundary condition of surface srfcId . More... | |
MInt & | a_surfaceOrientation (const MInt srfcId) |
Returns the orientation of surface srfcId . More... | |
MInt | a_surfaceOrientation (const MInt srfcId) const |
Returns the orientation of surface srfcId . More... | |
MFloat & | a_surfaceArea (const MInt srfcId) |
Returns the area of surface srfcId . More... | |
MFloat | a_surfaceArea (const MInt srfcId) const |
Returns the area of surface srfcId . More... | |
MFloat & | a_surfaceFactor (const MInt srfcId, const MInt varId) |
Returns the factor of surface srfcId for variable varId . More... | |
MFloat | a_surfaceFactor (const MInt srfcId, const MInt varId) const |
Returns the factor of surface srfcId for variable varId . More... | |
MFloat & | a_surfaceCoordinate (const MInt srfcId, const MInt dir) |
Returns the coordinate of surface srfcId in direction dir . More... | |
MFloat | a_surfaceCoordinate (const MInt srfcId, const MInt dir) const |
Returns the coordinate of surface srfcId in direction dir . More... | |
MFloat & | a_surfaceDeltaX (const MInt srfcId, const MInt varId) |
Returns the delta X of surface srfcId for variable varId . More... | |
MFloat | a_surfaceDeltaX (const MInt srfcId, const MInt varId) const |
Returns the delta X of surface srfcId for variable varId . More... | |
MInt & | a_surfaceNghbrCellId (const MInt srfcId, const MInt dir) |
Returns the neighbor cell id of surface srfcId in direction dir . More... | |
MInt | a_surfaceNghbrCellId (const MInt srfcId, const MInt dir) const |
Returns the neighbor cell id of surface srfcId in direction dir . More... | |
MFloat & | a_surfaceVariable (const MInt srfcId, const MInt dir, const MInt varId) |
Returns the variable varId of surface srfcId in direction dir . More... | |
MFloat | a_surfaceVariable (const MInt srfcId, const MInt dir, const MInt varId) const |
Returns the variable varId of surface srfcId in direction dir . More... | |
MFloat & | a_surfaceUpwindCoefficient (const MInt srfcId) |
Returns the upwind coefficient of surface srfcId . More... | |
MFloat | a_surfaceUpwindCoefficient (const MInt srfcId) const |
Returns the upwind coefficient of surface srfcId . More... | |
MFloat & | a_surfaceCoefficient (const MInt srfcId, const MInt dimCoefficient) |
Returns the coefficient dimCoefficient of surface srfcId . More... | |
MFloat | a_surfaceCoefficient (const MInt srfcId, const MInt dimCoefficient) const |
Returns the coefficient dimCoefficient of surface srfcId . More... | |
MFloat & | a_surfaceFlux (const MInt srfcId, const MInt fVarId) |
Returns the flux fVarId for surface srfcId . More... | |
MFloat | a_surfaceflux (const MInt srfcId, const MInt fVarId) const |
Returns the flux fVarId for surface srfcId . More... | |
MFloat & | a_Ma () |
Returns the Mach number of the solver. More... | |
const MFloat & | a_Ma () const |
Returns the Mach number of the solver. More... | |
MFloat & | a_cfl () |
Returns the cfl number of the solver. More... | |
const MFloat & | a_cfl () const |
MInt & | a_restartInterval () |
Returns the restart interval of the solver. More... | |
const MInt & | a_restartInterval () const |
Returns the restart interval of the solver. More... | |
MInt & | a_bndryCndId (MInt bndryId) |
Return BndryCndId. More... | |
const MInt & | a_bndryCndId (MInt bndryId) const |
Return BndryCndId. More... | |
MFloat & | a_bndryNormal (MInt bndryId, MInt dir) |
Return normal direction of bndry srfc. More... | |
const MFloat & | a_bndryNormal (MInt bndryId, MInt dir) const |
Return normal direction of bndry srfc. More... | |
MFloat & | a_bndryCutCoord (MInt bndryId, MInt i, MInt j) |
Return cut coordinates of bndry srfc. More... | |
const MFloat & | a_bndryCutCoord (MInt bndryId, MInt i, MInt j) const |
Return cut coordinates of bndry srfc. More... | |
const MInt & | a_bndryGhostCellId (const MInt bndryId, const MInt srfc) const |
MInt & | a_identNghbrId (MInt nghbrId) |
Return ident nghbr Id. More... | |
const MInt & | a_identNghbrId (MInt nghbrId) const |
Return ident nghbr Id. More... | |
MInt & | a_storeNghbrId (MInt nghbrId) |
Return store nghbr Id. More... | |
const MInt & | a_storeNghbrId (MInt nghbrId) const |
Return store nghbr Id. More... | |
MFloat & | a_VVInfinity (MInt dir) |
Return mean flow velocity. More... | |
const MFloat & | a_VVInfinity (MInt dir) const |
Return mean flow velocity. More... | |
MFloat & | a_rhoInfinity () |
Return rho infinity. More... | |
const MFloat & | a_rhoInfinity () const |
Return rho infinity. More... | |
MFloat & | a_PInfinity () |
Return p infinity. More... | |
const MFloat & | a_PInfinity () const |
Return p infinity. More... | |
MFloat & | a_TInfinity () |
Return T infinity. More... | |
const MFloat & | a_TInfinity () const |
Return T infinity. More... | |
MFloat & | a_timeRef () |
Return time reference value. More... | |
const MFloat & | a_timeRef () const |
Return time reference value. More... | |
MInt & | a_noPart (MInt cellId) |
Return no particles. More... | |
const MInt & | a_noPart (MInt cellId) const |
Return no particles. More... | |
MFloat & | a_physicalTime () |
Return physical time. More... | |
const MFloat & | a_physicalTime () const |
Return physical time. More... | |
MFloat & | a_time () |
Return time. More... | |
const MFloat & | a_time () const |
Return time. More... | |
MFloat & | a_externalSource (MInt cellId, MInt var) |
Return external source. More... | |
const MFloat & | a_externalSource (MInt cellId, MInt var) const |
Return external source. More... | |
MInt & | a_maxLevelWindowCells (MInt domain, MInt id) |
Return max level window cells. More... | |
const MInt & | a_maxLevelWindowCells (MInt domain, MInt id) const |
Return max level window cells. More... | |
MInt & | a_maxLevelHaloCells (MInt domain, MInt id) |
Return max level halo cells. More... | |
const MInt & | a_maxLevelHaloCells (MInt domain, MInt id) const |
Return max level halo cells. More... | |
MFloat & | a_localTimeStep (const MInt cellId) |
Returns the local time-step of the cell cellId . More... | |
MFloat | a_localTimeStep (const MInt cellId) const |
Returns the local time-step of the cell cellId . More... | |
MFloat | a_dynViscosity (const MFloat T) const |
MFloat & | a_levelSetFunction (const MInt cellId, const MInt set) |
Returns the levelSet-value for fv-CellId cellId and set . More... | |
MFloat | a_levelSetFunction (const MInt cellId, const MInt set) const |
Returns the levelSet-value for fv-CellId cellId and set . More... | |
MFloat & | a_levelSetValuesMb (const MInt cellId, const MInt set) |
Returns the levelSetMb-value for fv-CellId cellId and set . More... | |
MFloat | a_levelSetValuesMb (const MInt cellId, const MInt set) const |
Returns the levelSetMb-value for fv-CellId cellId and set . More... | |
MFloat | a_alphaGas (const MInt cellId) const |
MFloat & | a_alphaGas (const MInt cellId) |
MFloat | a_uOtherPhase (const MInt cellId, const MInt dir) const |
MFloat & | a_uOtherPhase (const MInt cellId, const MInt dir) |
MFloat | a_uOtherPhaseOld (const MInt cellId, const MInt dir) const |
MFloat & | a_uOtherPhaseOld (const MInt cellId, const MInt dir) |
MFloat | a_gradUOtherPhase (const MInt cellId, const MInt uDir, const MInt gradDir) const |
MFloat & | a_gradUOtherPhase (const MInt cellId, const MInt uDir, const MInt gradDir) |
MFloat | a_vortOtherPhase (const MInt cellId, const MInt dir) const |
MFloat & | a_vortOtherPhase (const MInt cellId, const MInt dir) |
MFloat | a_nuTOtherPhase (const MInt cellId) const |
MFloat & | a_nuTOtherPhase (const MInt cellId) |
MFloat | a_nuEffOtherPhase (const MInt cellId) const |
MFloat & | a_nuEffOtherPhase (const MInt cellId) |
MInt & | a_associatedBodyIds (const MInt cellId, const MInt set) |
Returns the associatedBodyIds for fv-CellId cellId and set . More... | |
MInt | a_associatedBodyIds (const MInt cellId, const MInt set) const |
Returns the associatedBodyIds for fv-CellId cellId and set . More... | |
MFloat & | a_curvatureG (const MInt cellId, const MInt set) |
Returns the curvature-value for fv-CellId cellId and set . More... | |
MFloat | a_curvatureG (const MInt cellId, const MInt set) const |
Returns the curvature-value for fv-CellId cellId and set . More... | |
MFloat & | a_flameSpeed (const MInt cellId, const MInt set) |
Returns the flamespeed-value for fv-CellId cellId and set . More... | |
MFloat | a_flameSpeed (const MInt cellId, const MInt set) const |
Returns the flamespeed-value for fv-CellId cellId and set . More... | |
MInt & | a_noSets () |
Returns the noSets for fv-CellId cellId and set . More... | |
MInt | a_noSets () const |
Returns the noSets for fv-CellId cellId and set . More... | |
MInt & | a_noLevelSetFieldData () |
Returns the noSets for fv-CellId cellId and set . More... | |
MInt | a_noLevelSetFieldData () const |
Returns the noSets for fv-CellId cellId and set . More... | |
const MInt & | getAssociatedInternalCell (const MInt &cellId) const |
Returns the Id of the split cell, if cellId is a split child. More... | |
virtual void | reIntAfterRestart (MBool) |
virtual void | resetRHS () |
virtual void | resetRHSCutOffCells () |
virtual void | initSolutionStep (MInt) |
Initializes the solver. More... | |
virtual void | applyInitialCondition () |
Initializes the entire flow field. More... | |
virtual void | Ausm () |
Dispatches the AUSM flux computation for different number of species. More... | |
virtual void | Muscl (MInt=-1) |
Reconstructs the flux on the surfaces. More... | |
virtual void | viscousFlux () |
virtual void | copyVarsToSmallCells () |
virtual void | computePV () |
virtual void | computePrimitiveVariables () |
Dispatches the computation of the primitive variables for different number of species. More... | |
virtual void | filterConservativeVariablesAtFineToCoarseGridInterfaces () |
virtual void | copyRHSIntoGhostCells () |
virtual void | LSReconstructCellCenter_Boundary () |
Computes the slopes at the cell centers of only the boundary cells. More... | |
virtual void | LSReconstructCellCenter () |
Dispatch the reconstruction computation to the appropiate loop. More... | |
virtual void | applyBoundaryCondition () |
handles the application of boundary conditions to the ghost cells More... | |
virtual void | cutOffBoundaryCondition () |
virtual void | computeConservativeVariables () |
Dispatches the computation of the conservative variables for different number of species. More... | |
virtual void | initNearBoundaryExchange (const MInt mode=0, const MInt offset=0) |
Setup the near-boundary communicator needed for the flux-redistribution method. More... | |
void | initAzimuthalNearBoundaryExchange (MIntScratchSpace &activeFlag) |
void | azimuthalNearBoundaryExchange () |
void | azimuthalNearBoundaryReverseExchange () |
void | setActiveFlag (MIntScratchSpace &, const MInt mode, const MInt offset) |
Set the flag for the cells needed for near bndry exchange. More... | |
virtual void | setAdditionalActiveFlag (MIntScratchSpace &) |
void | setInfinityState () |
Computes/defines the infinity values/state once and for all Ideally the infinity variables should not be updated outside of this function! More... | |
void | initAzimuthalCartesianHaloInterpolation () |
void | computeSurfaceCoefficients () |
Dispatches the transport coefficients computation at each surfaces by calling the relevant function from the detChemSysEqn class. Distinction between "Multi" and "Mix" transport models! Author: Borja Pedro. More... | |
void | computeSpeciesReactionRates () |
Dispatches the species reaction rate computation at each cell by calling the relevant method from the detChemSysEqn class. Author: Borja Pedro. More... | |
void | computeMeanMolarWeights_PV () |
Dispatches the mean molar weight computation at the cell center from the primitive variables by calling the relevant function from the detChemSysEqn class. The mean molar weight is stored inside the additional variables array. Author: Borja Pedro. More... | |
void | computeMeanMolarWeights_CV () |
Dispatches the mean molar weight computation at the cell center from the conservative variables by calling the relevant function from the detChemSysEqn class. The mean molar weight is stored inside the additional variables array. Author: Borja Pedro. More... | |
void | setMeanMolarWeight_CV (MInt cellId) |
Computes the mean molar weight at the given cell ID from the primitive variables. The mean molar weight is stored inside the additional variables array. Author: Borja Pedro. More... | |
void | setMeanMolarWeight_PV (MInt cellId) |
void | computeGamma () |
Dispatches the gamma computation at each cell by calling the relevant function from the detChemSysEqn class. It is stored inside the additional variables array, and used to compute the time step. Author: Borja Pedro. More... | |
void | computeDetailedChemistryVariables () |
void | setAndAllocateDetailedChemistryProperties () |
void | initCanteraObjects () |
Allocates the Cantera objects that define a thermodynamic phase, reaction kinetics and transport properties for a given reaction mechanism. More... | |
void | correctMajorSpeciesMassFraction () |
Corrects the mass fraction of the predominant species to ensure conservation due to numerical or approximation erros For combustion with air: N2 is the major species Author: Borja Pedro. More... | |
void | compute1DFlameSolution () |
void | addSpeciesReactionRatesAndHeatRelease () |
void | initHeatReleaseDamp () |
void | computeAcousticSourceTermQe (MFloatScratchSpace &, MFloatScratchSpace &, MFloatScratchSpace &, MFloatScratchSpace &) |
void | computeVolumeForces () |
void | computeRotForces () |
virtual MInt | getAdjacentLeafCells_d0 (const MInt, const MInt, MIntScratchSpace &, MIntScratchSpace &) |
virtual MInt | getAdjacentLeafCells_d1 (const MInt, const MInt, MIntScratchSpace &, MIntScratchSpace &) |
virtual MInt | getAdjacentLeafCells_d2 (const MInt, const MInt, MIntScratchSpace &, MIntScratchSpace &) |
virtual MInt | getAdjacentLeafCells_d0_c (const MInt, const MInt, MIntScratchSpace &, MIntScratchSpace &) |
virtual MInt | getAdjacentLeafCells_d1_c (const MInt, const MInt, MIntScratchSpace &, MIntScratchSpace &) |
virtual MInt | getAdjacentLeafCells_d2_c (const MInt, const MInt, MIntScratchSpace &, MIntScratchSpace &) |
MFloat | computeRecConstSVD (const MInt cellId, const MInt offset, MFloatScratchSpace &tmpA, MFloatScratchSpace &tmpC, MFloatScratchSpace &weights, const MInt recDim, const MInt, const MInt, const std::array< MBool, nDim > dirs={}, const MBool relocateCenter=false) |
compute the reconstruction constants of the given cell by a weighted least-squares approach via singular value decomposition More... | |
void | extendStencil (const MInt) |
extend the reconstruction sencil towards all diagonal cells on the first layer More... | |
MInt | samplingInterval () |
void | checkGhostCellIntegrity () |
Checks whether cells' isGhost and the boundary Id coincede. Cells' isGhost is is used to tell the grid about ghost cells. In the solver sometimes boundaryId == -2 is used to check for ghost cells. More... | |
virtual void | initializeRungeKutta () |
Reads the Runge-Kutta properties and initializes the variables required for Runge Kutta time stepping. More... | |
virtual void | initializeMaxLevelExchange () |
parallel: Store all necessary data in send buffer More... | |
virtual void | computePrimitiveVariablesCoarseGrid () |
Computes the primitive variables: velocity, density, and pressure from the conservative variables and stores the primitive variables in a_pvariable( i , v ) More... | |
void | initAzimuthalMaxLevelExchange () |
void | finalizeMpiExchange () |
Finalize non-blocking MPI communication (cancel open requests, free all requests) More... | |
void | setUpwindCoefficient () |
void | cellSurfaceMapping () |
void | interpolateSurfaceDiffusionFluxOnCellCenter (MFloat *const, MFloat *const) |
void | interpolateSurfaceDiffusionFluxOnCellCenter (MFloat *const NotUsed(JA), MFloat *const dtdn) |
void | setNghbrInterface () |
void | calcLESAverage () |
void | saveLESAverage () |
void | loadLESAverage () |
void | finalizeLESAverage () |
MFloat | getAveragingFactor () |
void | saveSpongeData () |
void | loadSpongeData () |
void | initSTGSpongeExchange () |
void | setAndAllocateZonalProperties () |
void | readPreliminarySTGSpongeData () |
void | calcPeriodicSpongeAverage () |
void | exchangeZonalAverageCells () |
virtual void | initSTGSponge () |
Initializes zonal exchange arrays. More... | |
virtual void | resetZonalLESAverage () |
Initializes zonal exchange arrays. More... | |
virtual void | determineLESAverageCells () |
virtual void | resetZonalSolverData () |
virtual void | getBoundaryDistance (MFloatScratchSpace &) |
Get distance to boundary, currently bc 3003. Should be replaced by more precise distance using STL information. More... | |
virtual void | nonReflectingBCAfterTreatmentCutOff () |
virtual void | nonReflectingBCCutOff () |
virtual void | dqdtau () |
virtual bool | rungeKuttaStep () |
Dispatches the RungeKutta method for different number of species. More... | |
virtual void | applyExternalSource () |
Add external sources to the RHS. More... | |
virtual void | applyExternalOldSource () |
virtual void | advanceExternalSource () |
void | exchangeExternalSources () |
Exchange external sources. More... | |
void | resetExternalSources () |
Reset external sources. More... | |
MInt | setUpBndryInterpolationStencil (const MInt, MInt *, const MFloat *) |
void | deleteSrfcs () |
Deletes all surfaces existing. More... | |
virtual void | resetRHSNonInternalCells () |
virtual void | correctMasterCells () |
adds the right hand side of small cells to their corresponding master cells and sets the small cell RHS to zero More... | |
void | writeCellData (MInt) |
virtual void | convertPrimitiveRestartVariables () |
converts the primitive restart variables to a new Mach Number More... | |
void | initializeFvCartesianSolver (const MBool *propertiesGroups) |
FV Constructor: reads and allocate properties/variables: More... | |
void | copyGridProperties () |
void | allocateCommunicationMemory () |
Allocates and initializes send/receive buffers for multiSolver computations. More... | |
void | setTestcaseProperties () |
Reads and initializes properties associated with the physics of the simulation and allocates small arrays of these properties. More... | |
void | setSamplingProperties () |
Reads properties associated with variable sampling. More... | |
void | setInputOutputProperties () |
Reads properties and initializes variables associated with input/output. More... | |
void | setNumericalProperties () |
Reads and initializes properties associated with the numerical method. More... | |
void | setAndAllocateCombustionTFProperties () |
Reads and initializes properties associated with combustion simulations. More... | |
void | setAndAllocateSpongeLayerProperties () |
Reads and initializes properties associated with sponge boundary conditions. More... | |
void | allocateAndInitSolverMemory () |
Allocates the resources of the FV solver. Mostly arrays of size maxNoCells used in the main part of the FV code plus - if required - moving grid arrays. IMPORTANT: This method should be called at the end of the FvCartesianSolver-Constructor, since other properties might be used in here, or datastructures previosly allocated might be referenced! More... | |
void | setRungeKuttaProperties () |
This function reads the properties required for Runge Kutta time stepping. More... | |
void | setAndAllocateAdaptationProperties () |
This function reads the properties required for adaptive mesh refinement. More... | |
virtual void | exchange () |
void | exchangeDataFV (T *data, const MInt blockSize=1, MBool cartesian=true, const std::vector< MInt > &rotIndex=std::vector< MInt >()) |
void | exchangeFloatDataAzimuthal (MFloat *data, MInt noVars, const std::vector< MInt > &rotIndices) |
void | exchangeDataAzimuthal (T *data, const MInt dataBlockSize=1) |
void | exchangeAzimuthalRemappedHaloCells () |
virtual void | exchangePeriodic () |
void | exchangePipe () |
void | startMpiExchange () |
Begin non-blocking communication by posting new send requests. More... | |
void | prepareMpiExchange () |
void | finishMpiExchange () |
Finish non-blocking communication by waiting for receive requests. More... | |
void | cancelMpiRequests () override |
Cancel open MPI (receive) requests. More... | |
void | gather () |
Gather data of all window cells for all neighbors in the send buffers. More... | |
void | receive (const MBool exchangeAll=false) |
Receive halo cell data from corresponding neighbors. More... | |
void | send (const MBool exchangeAll=false) |
Send window cell data to corresponding neighbors. More... | |
void | scatter () |
Scatter received data of all neighbors to the corresponding halo cells. More... | |
void | exchangeAll () |
virtual void | computeReconstructionConstants () |
virtual void | findNghbrIds () |
void | getPrimitiveVariables (MInt, MFloat *, MFloat *, MInt) |
void | rhs () |
void | rhsBnd () |
void | initSolver () override |
Initializes the fv-solver. More... | |
void | finalizeInitSolver () override |
Initializes the solver afer the initialRefinement! More... | |
void | preSolutionStep (MInt) override |
MBool | solutionStep () override |
Performs one Runge-Kutta step of the FV solver, returns true if the time step is completed. More... | |
MBool | postSolutionStep () override |
MBool | solverStep () |
void | postTimeStep () override |
: Performs the post time step More... | |
void | scalarLimiter () |
void | cleanUp () override |
void | lhsBndFinish () |
Finish the split MPI communication and perform the left out part from lhsBnd(). More... | |
void | lhsBnd () |
Apply lhsBnd. More... | |
virtual void | smallCellCorrection (const MInt timerId=-1) |
Flux-redistribution method Apply a stable correction to small-cells and redistribute the defective flux to neighboring cells to re-establish conservation For details see Schneiders,Hartmann,Meinke,Schröder, J.Comput.Phys. 235 (2013) For more details see the dissertation of Lennart Schneiders, "Particle-Resolved
Analysis of Turbulent Multiphase Flow by a Cut-Cell Method" Chapter 3.4. More... | |
virtual void | smallCellRHSCorrection (const MInt timerId=-1) |
virtual void | updateSplitParentVariables () |
virtual void | checkDiv () |
virtual void | updateMaterialNo () |
void | initSourceCells () |
void | revertTimestep () |
void | rhsEEGas () |
virtual void | resetImplicitCoefficients () |
MFloat | physicalTime () |
MFloat | computeDomainLength (MInt direction) |
const Geom & | geometry () const |
the references to CartesianGrid data members end here More... | |
MPI_Comm | globalMpiComm () const |
Return the global MPI communicator used by the grid. More... | |
void | createGridSlice (const MString &direction, const MFloat intercept, const MString &fileName, MInt *const sliceCellIds) |
MInt | noVariables () const override |
Return the number of primitive variables. More... | |
void | releaseMemory () |
constexpr MBool | isMultilevel () const |
Return true if solver is part of a multilevel computation. More... | |
constexpr MBool | isMultilevelPrimary () const |
Return true if solver is primary solver in multilevel computation. More... | |
constexpr MBool | isMultilevelLowestSecondary () const |
void | setMultilevelPrimary (const MBool state=true) |
Designates solver as primary solver in multilevel computation. More... | |
void | setMultilevelSecondary (const MBool state=true) |
constexpr MBool | isZonal () const |
void | loadSampleVariables (MInt timeStep) |
load variables for the specified timeStep More... | |
void | getSampleVariables (MInt cellId, const MFloat *&vars) |
read only access to primitive variables of a single cell More... | |
void | getSampleVariables (MInt const cellId, std::vector< MFloat > &vars) |
void | getSampleVariableNames (std::vector< MString > &varNames) override |
Return the sample variable names (primitive variables) More... | |
virtual void | getSampleVarsDerivatives (const MInt cellId, const MFloat *&vars) |
Access derivatives of primitive variables of a given cell. More... | |
MBool | getSampleVarsDerivatives (const MInt cellId, std::vector< MFloat > &vars) |
void | calculateHeatRelease () |
calculates heatRelease, currently used for postprocessing (average_in) More... | |
void | getHeatRelease (MFloat *&heatRelease) |
returns More... | |
virtual void | getVorticity (MFloat *const vorticity) |
wrapper for vorticity computation More... | |
virtual void | getVorticityT (MFloat *const vorticity) |
wrapper for vorticity computation (transposed version) More... | |
void | oldPressure (MFloat *const p) |
This function computes the pressure from the oldVariables. More... | |
virtual MFloat & | vorticityAtCell (const MInt cellId, const MInt dir) |
virtual MFloat | getBoundaryHeatFlux (const MInt cellId) const |
calculates heat flux of boundary cells More... | |
MFloat | time () const override |
returns the time More... | |
virtual void | getDimensionalizationParams (std::vector< std::pair< MFloat, MString > > &dimParams) const |
get dimensionalization parameters More... | |
MInt | getCellIdByIndex (const MInt index) |
Required for sampling, for FV the index is already the cell id. More... | |
MInt | getIdAtPoint (const MFloat *point, MBool NotUsed(globalUnique=false)) |
Return the leaf cell id containing the given point. More... | |
virtual void | getSolverSamplingProperties (std::vector< MInt > &samplingVars, std::vector< MInt > &noSamplingVars, std::vector< std::vector< MString > > &samplingVarNames, const MString featureName="") override |
Read sampling related properties. More... | |
virtual void | initSolverSamplingVariables (const std::vector< MInt > &varIds, const std::vector< MInt > &noSamplingVars) override |
Initialize sampling variables/allocate memory. More... | |
virtual void | calcSamplingVariables (const std::vector< MInt > &varIds, const MBool exchange) override |
Calculate sampling variables. More... | |
virtual void | initInterpolationForCell (const MInt cellId) |
Init the interpolation for points inside a given cell (based on interpolateVariables()) More... | |
virtual void | calcSamplingVarAtPoint (const MFloat *point, const MInt id, const MInt sampleVarId, MFloat *state, const MBool interpolate=false) override |
Calculate the sampling variables at a given point in a cell. More... | |
MInt | getCurrentTimeStep () const override |
Return the current time step. More... | |
MBool | hasRestartTimeStep () const override |
MInt | determineRestartTimeStep () const override |
Determine the restart time step from the restart file (for useNonSpecifiedRestartFile = true) More... | |
virtual void | finalizeInitEnthalpySolver () |
virtual void | initMatDat () |
virtual void | writeVtkXmlFiles (const MString, const MString, MBool, MBool) |
MBool | calcSlopesAfterStep () |
Return if slopes should be calculated at after each step (not before) More... | |
void | applyCoarseLevelCorrection () |
Apply coarse-level correction to RHS. More... | |
void | setAndAllocateCombustionGequPvProperties () |
reads in the combustion properties More... | |
void | setAndAllocateSpongeBoundaryProperties () |
reads in the sponge properties for specific boundaries More... | |
MFloat | setAndAllocateSpongeDomainProperties (MFloat) |
reads in the sponge properties for the domain boundaries More... | |
void | setCombustionGequPvVariables () |
reads in the combustion properties More... | |
MInt | noSolverTimers (const MBool allTimings) override |
void | getSolverTimings (std::vector< std::pair< MString, MFloat > > &solverTimings, const MBool allTimings) override |
Get solver timings. More... | |
void | limitWeights (MFloat *) override |
Limit Weight types to avoid large memory disbalance between ranks for DLB. More... | |
MInt | noCellDataDlb () const override |
Methods to inquire solver data information. More... | |
MInt | cellDataTypeDlb (const MInt dataId) const override |
MInt | cellDataSizeDlb (const MInt dataId, const MInt gridCellId) override |
Return data size to be communicated during DLB for a grid cell and given data id. More... | |
void | getCellDataDlb (const MInt dataId, const MInt oldNoCells, const MInt *const bufferIdToCellId, MFloat *const data) override |
Return solver data for DLB. More... | |
void | setCellDataDlb (const MInt dataId, const MFloat *const data) override |
Set solver data for DLB. More... | |
void | getGlobalSolverVars (std::vector< MFloat > &globalFloatVars, std::vector< MInt > &globalIdVars) override |
Get/set global solver variables during DLB. More... | |
void | setGlobalSolverVars (std::vector< MFloat > &globalFloatVars, std::vector< MInt > &globalIdVars) override |
Set global solver variables (see getGlobalSolverVars()) More... | |
MBool | hasSplitBalancing () const override |
Return if load balancing for solver is split into multiple methods or implemented in balance() More... | |
virtual MBool | adaptationTrigger () |
MBool | forceAdaptation () override |
void | bubblePathDispersion () |
void | computePrimitiveVariablesCoarseGrid (MInt) |
Computes the primitive variables: velocity, density, and pressure from the conservative variables and stores the primitive variables in a_pvariable( i , v ) More... | |
void | forceTimeStep (const MFloat dt) |
Force time step externally. More... | |
MInt | a_timeStepComputationInterval () |
void | preTimeStep () override |
void | computeVolumeForcesRANS () |
void | exchangeGapInfo () |
exchanges the Gap-Information with the solver-own communicators! More... | |
void | resetCutOffCells () |
resets all Cut-Off Information should only be called before the adaptation and balance! More... | |
void | resetSponge () |
reset sponge properties More... | |
void | exchangeProperties () |
exchanges isInactive and isOnCurrentMGLevel More... | |
void | computeUTau (MFloat *data, MInt cellId) |
void | computeDomainAndSpongeDimensions () |
Extracts the minimum and maximum coordinates of all cells in the grid. More... | |
virtual void | updateSpongeLayer () |
computes the additional rhs of all cells lying inside the sponge layer to dissipate outgoing waves. More... | |
std::array< MFloat, 6 > | computeTargetValues () |
std::array< MFloat, nDim_+2 > | computeSpongeDeltas (MInt cellId, std::array< MFloat, 6 >) |
void | updateSpongeLayerRhs (MInt, std::array< MFloat, nDim_+2 >) |
void | checkCells () |
void | checkForSrfcsMGC () |
Check all existing cells if surfaces have to be created member function with the task to check all existing cells for the creation of surfaces. If a surface has to be created, another member function is called. More... | |
void | checkForSrfcsMGC_2 () |
void | checkForSrfcsMGC_2_ () |
Check all existing cells if surfaces have to be created member function with the task to check all existing cells for the creation of surfaces. If a surface has to be created, another member function is called. More... | |
void | computeSrfcs (MInt, MInt, MInt, MInt) |
virtual void | correctBoundarySurfaces () |
virtual void | correctBoundarySurfaces_ () |
void | checkCellSurfaces () |
checks if the surfaces for a cell are correct and balanced The accumulated cell surfaces in +x direction must be balanced by the accumulated cell surfaces in -x direction and so on. If the surfaces are not balanced, the cell is loggd to the debug output method is not yet extended to moving boundary computations More... | |
void | computeCellSurfaceDistanceVectors () |
void | computeReconstructionConstantsSVD () |
Compute the reconstruction constants using a weighted least squares approached solved via singular value decomposition. More... | |
void | setConservativeVarsOnAzimuthalRecCells () |
void | initAzimuthalReconstruction () |
virtual void | computeAzimuthalReconstructionConstants (MInt mode=0) |
void | rebuildAzimuthalReconstructionConstants (MInt cellId, MInt offset, MFloat *recCoord, MInt mode=0) |
void | interpolateAzimuthalData (MFloat *data, MInt offset, MInt noVars, const MFloat *vars) |
void | fillExcBufferAzimuthal (MInt cellId, MInt offset, MFloat *dataDest, MFloat *dataSrc, MInt noData, const std::vector< MInt > &rotIndex=std::vector< MInt >()) |
void | rotateVectorAzimuthal (MInt side, MFloat *data, MInt noData, const std::vector< MInt > &indices) |
void | interpolateAzimuthalDataReverse (MFloat *data, MInt offset, MInt noVars, const MFloat *vars) |
void | checkAzimuthalRecNghbrConsistency (MInt cellId) |
void | buildLeastSquaresStencilSimple () |
Determine the least squares stencil. More... | |
void | initViscousFluxComputation () |
void | computeRecConstPeriodic () |
void | computeRecConstPeriodic_ () |
void | identPeriodicCells () |
void | identPeriodicCells_ () |
ATTRIBUTES2 (ATTRIBUTE_ALWAYS_INLINE, ATTRIBUTE_HOT) inline void LSReconstructCellCenter_(const MUint noSpecies) | |
ATTRIBUTES2 (ATTRIBUTE_HOT, ATTRIBUTE_FLATTEN) virtual void computeSurfaceValues(MInt timerId | |
ATTRIBUTES2 (ATTRIBUTE_ALWAYS_INLINE, ATTRIBUTE_HOT) inline void computeSurfaceValues_(const MUint) | |
ATTRIBUTES2 (ATTRIBUTE_HOT, ATTRIBUTE_FLATTEN) virtual void computeSurfaceValuesLimited(MInt timerId | |
ATTRIBUTES2 (ATTRIBUTE_HOT, ATTRIBUTE_ALWAYS_INLINE) inline void computePrimitiveVariables_() | |
ATTRIBUTES2 (ATTRIBUTE_HOT, ATTRIBUTE_ALWAYS_INLINE) inline MBool uDLimiter(const MFloat *const | |
ATTRIBUTES2 (ATTRIBUTE_HOT, ATTRIBUTE_ALWAYS_INLINE) inline void computeConservativeVariables_() | |
ATTRIBUTES2 (ATTRIBUTE_HOT, ATTRIBUTE_ALWAYS_INLINE) inline MBool rungeKuttaStep_(const MUint) | |
ATTRIBUTES2 (ATTRIBUTE_HOT, ATTRIBUTE_ALWAYS_INLINE) inline MBool rungeKuttaStepEEGas() | |
void | LSReconstructCellCenterCons (const MUint noSpecies) |
virtual void | computeSurfaceValuesLOCD (MInt timerId=-1) |
virtual void | computeLimitedSurfaceValues (MInt timerId=-1) |
virtual void | computeSurfaceValuesLimitedSlopes (MInt timerId=-1) |
virtual void | computeSurfaceValuesLimitedSlopesMan (MInt timerId=-1) |
aaplies the slope limiter to the slopes before calling computeSurfaceValues_ More... | |
virtual void | initComputeSurfaceValuesLimitedSlopesMan1 () |
initializes the limiter at cells, that are in the vicinity of a given stl-geometry More... | |
virtual void | initComputeSurfaceValuesLimitedSlopesMan2 () |
can be used to apply the slope limiter at certain positions such as refinement interfaces, cut off boundaries(sponge) etc. ... More... | |
void | computeGridCellCoordinates (MFloat *) |
computes the coordinates of the grid cell centers and stores them into a one-dimensional array More... | |
void | findNghbrIdsMGC () |
void | findDirectNghbrs (MInt cellId, std::vector< MInt > &nghbrList) |
Obtain list of direct neighbors of given cell. More... | |
void | findNeighborHood (MInt cellId, MInt layer, std::vector< MInt > &nghbrList) |
Obtain list of neighbors for the given extend. More... | |
void | refineCell (const MInt) override |
void | removeChilds (const MInt) override |
void | removeCell (const MInt) override |
Remove the given cell. More... | |
void | swapCells (const MInt, const MInt) override |
void | resizeGridMap () override |
Swap the given cells. More... | |
void | swapProxy (const MInt, const MInt) override |
MBool | cellOutside (const MInt) |
MInt | cellOutside (const MFloat *, const MInt, const MInt) override |
virtual void | resetSurfaces () |
virtual void | resetBoundaryCells (const MInt offset=0) |
void | reInitActiveCellIdsMemory () |
Allocate memory to arrays according to the current number of cells. More... | |
void | reInitSmallCellIdsMemory () |
Reallocate memory to small and master cell id arrays according to the current number of cells. More... | |
void | prepareAdaptation () override |
void | setSensors (std::vector< std::vector< MFloat > > &sensors, std::vector< MFloat > &sensorWeight, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MInt > &sensorSolverId) override |
set the sensors for the adaptation (i.e. which cell should be refined/removed?) More... | |
void | postAdaptation () override |
void | finalizeAdaptation () override |
void | sensorInterface (std::vector< std::vector< MFloat > > &sensors, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MFloat > &sensorWeight, MInt sensorOffset, MInt sen) override |
void | sensorInterfaceDelta (std::vector< std::vector< MFloat > > &sensors, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MFloat > &sensorWeight, MInt sensorOffset, MInt sen) |
void | sensorInterfaceLsMb (std::vector< std::vector< MFloat > > &sensors, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MFloat > &sensorWeight, MInt sensorOffset, MInt sen) |
void | sensorInterfaceLs (std::vector< std::vector< MFloat > > &sensors, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MFloat > &sensorWeight, MInt sensorOffset, MInt sen) |
void | sensorCutOff (std::vector< std::vector< MFloat > > &sensors, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MFloat > &sensorWeight, MInt sensorOffset, MInt sen) |
void | sensorPatch (std::vector< std::vector< MFloat > > &sensors, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MFloat > &sensorWeight, MInt sensorOffset, MInt sen) override |
void | bandRefinementSensorDerivative (std::vector< std::vector< MFloat > > &sensors, std::vector< std::bitset< 64 > > &sensorCellFlag, MInt sensorOffset, MInt sen, const std::vector< MFloat > &tau, const MFloat sensorThreshold) |
virtual void | updateMultiSolverInformation (MBool fullReset=false) |
void | resetSolver () override |
Reset the solver prior to load balancing. More... | |
virtual void | resetSolverFull () |
void | setCellWeights (MFloat *) override |
void | balance (const MInt *const noCellsToReceiveByDomain, const MInt *const noCellsToSendByDomain, const MInt *const targetDomainsByCell, const MInt oldNoCells) override |
Balance the solver. More... | |
void | balancePre () override |
Reinitialize solver for DLB prior to setting solution data. More... | |
void | balancePost () override |
Reinitialize solver after setting solution data in DLB. More... | |
void | finalizeBalance () override |
Reinitialize solver after all data structures have been recreated. More... | |
MInt | noLoadTypes () const override |
void | getDefaultWeights (MFloat *weights, std::vector< MString > &names) const |
Return the default weights for all load quantities. More... | |
void | getLoadQuantities (MInt *const loadQuantities) const override |
Return the cumulative load quantities on this domain. More... | |
MFloat | getCellLoad (const MInt cellId, const MFloat *const weights) const override |
Return the load of a single cell (given computational weights). More... | |
void | getDomainDecompositionInformation (std::vector< std::pair< MString, MInt > > &domainInfo) override |
Return decomposition information, i.e. number of local elements,... More... | |
void | saveSolverSolution (const MBool forceOutput=false, const MBool finalTimeStep=false) override |
Manages solver-specific output. More... | |
void | writeRestartFile (const MBool, const MBool, const MString, MInt *) override |
void | writeRestartFile (MBool) override |
MBool | prepareRestart (MBool, MBool &) override |
Prepare the solvers for a grid-restart. More... | |
void | saveSampleFiles () |
virtual void | saveRestartFile (const MBool) |
void | saveDebugRestartFile () |
Saves the solver restart file and the grid restartFile NOTE: for debugging purposes only! for regular output use the saveRestartFile above! More... | |
void | loadRestartFile () override |
void | computeConservativeVariablesCoarseGrid () |
Computes the primitive variables: velocity, density, and pressure from the conservative variables and stores the primitive variables in a_pvariable( i , v ) More... | |
void | writeCenterLineVel () |
void | computeForceCoefficients (MFloat *) |
void | checkInfinityVarsConsistency () |
Check that all infinity (or other global) variables are equal on all ranks. More... | |
void | computeInitialPressureLossForChannelFlow () |
Computes pressure loss for the initial condition of channel flow testcases as \( \Delta_p =
\frac{(\mathit{M} \mathit{Re}_{\tau} \sqrt{T_{\infty}})^{2}}{\mathit{Re}}
\frac{\rho_{\infty}}{ L_{\infty} } \). Requires property ReTau to be set in the property file. More... | |
void | Ausm_ (F &fluxFct) |
void | viscousFlux_ (F &viscousFluxFct) |
Computes the viscous flux using a central difference scheme to approximate the slopes at the surface centroids (5-point stencil). More... | |
void | viscousFluxCompact_ (F &viscousFluxFct) |
Computes the viscous fluxes using a compact stencil with increased stability for flows with dominating viscous effects. Uses a 3-point centered-differences stencil for the normal derivative and distance-weighted averaging of the cell slopes for the tangential derivatives (i.e., a variant of the method described by Berger et al. in AIAA 2012-1301) More... | |
void | viscousFluxMultiSpecies_ () |
void | computeConservativeVariablesMultiSpecies_ (const MUint) |
void | computePrimitiveVariablesMultiSpecies_ (const MUint) |
virtual void | distributeFluxToCells () |
Distributes the surface fluxes to the cell RHS. More... | |
void | implicitTimeStep () override |
void | computeCellVolumes () |
void | computeSamplingTimeStep () |
void | computeSamplingTimeStep_ () |
computes the time step according to the sample variables More... | |
void | computeCoarseGridCorrection (MInt) |
void | linearInterpolation (MInt, MInt, MInt *) |
void | bilinearInterpolation (MInt, MInt, MInt *) |
void | bilinearInterpolationAtBnd (MInt, MInt, MInt *) |
void | initCutOffBoundaryCondition () |
virtual void | setConservativeVariables (MInt cellId) |
computes conservative from primitive variables for given cell id More... | |
void | setPrimitiveVariables (MInt cellId) |
computes primitive from primitive variables for given cell id. This is the version for all SysEqn. More... | |
void | initDepthCorrection () |
void | divCheck (MInt) |
MInt | getAdjacentLeafCells (const MInt, const MInt, MIntScratchSpace &, MIntScratchSpace &) |
retrieves the first 'noLayers' layers of direct and(or diagonal neighbors to the given cell More... | |
MInt | getNghbrLeafCells (const MInt cellId, MInt refCell, MInt layer, MInt *nghbrs, MInt dir, MInt dir1=-1, MInt dir2=-1) const |
returns the neighbor leaf cells in the specified direction 'dir' (dir1 and dir2 are used to identify only neighboring children beeing adjacent to the root cell) More... | |
void | reduceVariables () |
Check whether any of the extracted cells lie below the halo cell level and interpolate their variables in that case. More... | |
void | computeSlopesByCentralDifferences () |
void | generateBndryCells () |
void | createBoundaryCells () |
identifies bndry cells (Sets a_isInterface for the solver!) More... | |
void | getInterpolatedVariables (const MInt cellId, const MFloat *position, MFloat *vars) override |
calculates interpolated variables for a given position in a given cell More... | |
void | getInterpolatedVariables (const MInt cellId, const MFloat *position, MFloat *vars) |
void | getInterpolatedVariablesInCell (const MInt cellId, const MFloat *position, MFloat *vars) |
calculates interpolated variables for a given position in a given cell More... | |
void | interpolateVariables (const MInt cellId, const MFloat *position, MFloat *result) |
calculates interpolated variables (in the range a, b) for a given position in a given cell More... | |
void | interpolateVariablesInCell (const MInt cellId, const MFloat *position, std::function< MFloat(MInt, MInt)> variables, MFloat *result) |
Interpolate the given variable field inside a cell at a given position (based on interpolateVariables() but uses the stored interpolation information for a cell). More... | |
MFloat | crankAngle (const MFloat, const MInt) |
help-function for engine calculations which returns the crank-angle for a given time mode = 0: return CAD in range of (0-720) mode = 1: return accumulated crankAnge in radian More... | |
MFloat | cv_p (MInt cellId) const noexcept |
Returns the pressure computed from the conservative variables of the cell cellId . More... | |
MFloat | cv_T (MInt cellId) const noexcept |
Returns the temperature computed from the conservative variables of the cell cellId . More... | |
MFloat | cv_a (MInt cellId) const noexcept |
Returns the speed-of-sound computed from the conservative variables of the cell cellId . More... | |
void | setTimeStep () |
void | initSandpaperTrip () |
void | applySandpaperTrip () |
void | saveSandpaperTripVars () |
void | tripForceCoefficients (MFloat *, MFloat *, MFloat *, MInt, MInt) |
void | tripFourierCoefficients (MFloat *, MInt, MFloat, MFloat) |
void | dumpCellData (const MString name) |
Dump cell data of each rank to a separate file for debugging purposes. More... | |
Public Member Functions inherited from maia::CartesianSolver< nDim, SolverType > | |
CartesianSolver (const MInt solverId, GridProxy &gridProxy_, const MPI_Comm comm, const MBool checkActive=false) | |
MInt | minLevel () const |
Read-only accessors for grid data. More... | |
MInt | maxLevel () const |
MInt | maxNoGridCells () const |
MInt | maxRefinementLevel () const |
MInt | maxUniformRefinementLevel () const |
MInt | noNeighborDomains () const |
MInt | neighborDomain (const MInt id) const |
MLong | domainOffset (const MInt id) const |
MInt | noHaloLayers () const |
MInt | noHaloCells (const MInt domainId) const |
MInt | haloCellId (const MInt domainId, const MInt cellId) const |
MInt | noWindowCells (const MInt domainId) const |
MInt | windowCellId (const MInt domainId, const MInt cellId) const |
MString | gridInputFileName () const |
MFloat | reductionFactor () const |
MFloat | centerOfGravity (const MInt dir) const |
MInt | neighborList (const MInt cellId, const MInt dir) const |
const MLong & | localPartitionCellGlobalIds (const MInt cellId) const |
MLong | localPartitionCellOffsets (const MInt index) const |
MInt | noMinCells () const |
MInt | minCell (const MInt id) const |
const MInt & | haloCell (const MInt domainId, const MInt cellId) const |
const MInt & | windowCell (const MInt domainId, const MInt cellId) const |
MBool | isActive () const override |
constexpr GridProxy & | grid () const |
GridProxy & | grid () |
virtual void | sensorDerivative (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorDivergence (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorTotalPressure (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorEntropyGrad (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorEntropyQuot (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorVorticity (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorInterface (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
void | sensorLimit (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt, std::function< MFloat(MInt)>, const MFloat, const MInt *, const MBool, const MBool allowCoarsening=true) |
simple sensor to apply a limit for a value More... | |
void | sensorSmooth (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
sensor to smooth level jumps NOTE: only refines additional cells to ensure a smooth level transition this requires that all other sensors are frozen i.e. no refine/coarse sensors set! More... | |
void | sensorBand (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
This sensor generates a max refinement band around the cells with max refinement level. In order for it to work, the property addedAdaptationSteps has to be equal to /maxRefinementLevel() - minLevel()/. This sensor also ensures a smooth transition between levels. Do not use together with sensorSmooth. More... | |
virtual void | sensorMeanStress (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorParticle (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorSpecies (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
virtual void | sensorPatch (std::vector< std::vector< MFloat > > &sensor, std::vector< std::bitset< 64 > > &sensorCellFlag, std::vector< MFloat > &sensorWeight, MInt sensorOffset, MInt sen) |
virtual void | sensorCutOff (std::vector< std::vector< MFloat > > &, std::vector< std::bitset< 64 > > &, std::vector< MFloat > &, MInt, MInt) |
void | saveSensorData (const std::vector< std::vector< MFloat > > &sensors, const MInt &level, const MString &gridFileName, const MInt *const recalcIds) override |
Saves all sensor values for debug/tunig purposes. More... | |
void | assertValidGridCellId (const MInt) const |
MLong | c_parentId (const MInt cellId) const |
Returns the grid parent id of the cell cellId . More... | |
MLong | c_neighborId (const MInt cellId, const MInt dir) const |
Returns the grid neighbor id of the grid cell cellId dir . More... | |
MInt | c_noCells () const |
MInt | c_level (const MInt cellId) const |
MLong | c_globalGridId (const MInt cellId) |
template<typename T > | |
void | exchangeData (T *data, const MInt dataBlockSize=1) |
Exchange memory in 'data' assuming a solver size of 'dataBlockSize' per cell. More... | |
template<typename T > | |
void | exchangeLeafData (std::function< T &(MInt, MInt)> data, const MInt noDat=1) |
Blocking exchange memory in 'data' assuming a solver size of 'dataBlockSize' per cell NOTE: exchange is only performed on leaf-cells and leaf-NeighborDomains Assumes, that updateLeafCellExchange has been called in the proxy previously! More... | |
template<class G , class S , class M > | |
void | exchangeSparseLeafValues (G getData, S setData, const MInt dataSize, M cellMapping) |
Exchange of sparse data structures on max Level. More... | |
template<typename T > | |
void | exchangeAzimuthalPer (T *data, MInt dataBlockSize=1, MInt firstBlock=0) |
Exchange of sparse data structures on max Level. More... | |
template<typename T > | |
void | collectVariables (T *variablesIn, ScratchSpace< T > &variablesOut, const std::vector< MString > &variablesNameIn, std::vector< MString > &variablesNameOut, const MInt noVars, const MInt noCells, const MBool reverseOrder=false) |
generalised helper function for writing restart files! This is necessary for example if the minLevel shall be raised at the new restart! More... | |
template<typename T > | |
void | collectVariables (T **variablesIn, ScratchSpace< T > &variablesOut, const std::vector< MString > &variablesNameIn, std::vector< MString > &variablesNameOut, const MInt noVars, const MInt noCells) |
generalised helper function for writing restart files! This is necessary for example if the minLevel shall be raised at the new restart! More... | |
void | saveGridFlowVars (const MChar *fileName, const MChar *gridFileName, const MInt noTotalCells, const MInt noInternal, MFloatScratchSpace &dbVariables, std::vector< MString > &dbVariablesName, MInt noDbVars, MIntScratchSpace &idVariables, std::vector< MString > &idVariablesName, MInt noIdVars, MFloatScratchSpace &dbParameters, std::vector< MString > &dbParametersName, MIntScratchSpace &idParameters, std::vector< MString > &idParametersName, MInt *recalcIds, MFloat time) |
This function writes the parallel Netcdf cartesian grid cell based solution/restart file currently used in PostData, LPT and LS solvers! More... | |
template<typename T > | |
void | collectParameters (T, ScratchSpace< T > &, const MChar *, std::vector< MString > &) |
This function collects a single parameters for the massivley parallel IO functions. More... | |
void | calcRecalcCellIdsSolver (const MInt *const recalcIdsTree, MInt &noCells, MInt &noInternalCellIds, std::vector< MInt > &recalcCellIdsSolver, std::vector< MInt > &reorderedCellIds) |
Derive recalc cell ids of the solver and reordered cell ids. More... | |
Public Member Functions inherited from Solver | |
MString | getIdentifier (const MBool useSolverId=false, const MString preString="", const MString postString="_") |
virtual | ~Solver ()=default |
virtual MInt | noInternalCells () const =0 |
Return the number of internal cells within this solver. More... | |
virtual MFloat | time () const =0 |
Return the time. More... | |
virtual MInt | noVariables () const |
Return the number of variables. More... | |
virtual void | getDimensionalizationParams (std::vector< std::pair< MFloat, MString > > &) const |
Return the dimensionalization parameters of this solver. More... | |
void | updateDomainInfo (const MInt domainId, const MInt noDomains, const MPI_Comm mpiComm, const MString &loc) |
Set new domain information. More... | |
virtual MFloat & | a_slope (const MInt, MInt const, const MInt) |
virtual MBool | a_isBndryCell (const MInt) const |
virtual MFloat & | a_FcellVolume (MInt) |
virtual MInt | getCurrentTimeStep () const |
virtual void | accessSampleVariables (MInt, MFloat *&) |
virtual void | getSampleVariableNames (std::vector< MString > &NotUsed(varNames)) |
virtual MBool | a_isBndryGhostCell (MInt) const |
virtual void | saveCoarseSolution () |
virtual void | getSolverSamplingProperties (std::vector< MInt > &NotUsed(samplingVarIds), std::vector< MInt > &NotUsed(noSamplingVars), std::vector< std::vector< MString > > &NotUsed(samplingVarNames), const MString NotUsed(featureName)="") |
virtual void | initSolverSamplingVariables (const std::vector< MInt > &NotUsed(varIds), const std::vector< MInt > &NotUsed(noSamplingVars)) |
virtual void | calcSamplingVariables (const std::vector< MInt > &NotUsed(varIds), const MBool NotUsed(exchange)) |
virtual void | calcSamplingVarAtPoint (const MFloat *NotUsed(point), const MInt NotUsed(id), const MInt NotUsed(sampleVarId), MFloat *NotUsed(state), const MBool NotUsed(interpolate)=false) |
virtual void | balance (const MInt *const NotUsed(noCellsToReceiveByDomain), const MInt *const NotUsed(noCellsToSendByDomain), const MInt *const NotUsed(targetDomainsByCell), const MInt NotUsed(oldNoCells)) |
Perform load balancing. More... | |
virtual MBool | hasSplitBalancing () const |
Return if load balancing for solver is split into multiple methods or implemented in balance() More... | |
virtual void | balancePre () |
virtual void | balancePost () |
virtual void | finalizeBalance () |
virtual void | resetSolver () |
Reset the solver/solver for load balancing. More... | |
virtual void | cancelMpiRequests () |
Cancel open mpi (receive) requests in the solver (e.g. due to interleaved execution) More... | |
virtual void | setCellWeights (MFloat *) |
Set cell weights. More... | |
virtual MInt | noLoadTypes () const |
virtual void | getDefaultWeights (MFloat *NotUsed(weights), std::vector< MString > &NotUsed(names)) const |
virtual void | getLoadQuantities (MInt *const NotUsed(loadQuantities)) const |
virtual MFloat | getCellLoad (const MInt NotUsed(cellId), const MFloat *const NotUsed(weights)) const |
virtual void | limitWeights (MFloat *NotUsed(weights)) |
virtual void | localToGlobalIds () |
virtual void | globalToLocalIds () |
virtual MInt | noCellDataDlb () const |
Methods to inquire solver data information. More... | |
virtual MInt | cellDataTypeDlb (const MInt NotUsed(dataId)) const |
virtual MInt | cellDataSizeDlb (const MInt NotUsed(dataId), const MInt NotUsed(cellId)) |
virtual void | getCellDataDlb (const MInt NotUsed(dataId), const MInt NotUsed(oldNoCells), const MInt *const NotUsed(bufferIdToCellId), MInt *const NotUsed(data)) |
virtual void | getCellDataDlb (const MInt NotUsed(dataId), const MInt NotUsed(oldNoCells), const MInt *const NotUsed(bufferIdToCellId), MLong *const NotUsed(data)) |
virtual void | getCellDataDlb (const MInt NotUsed(dataId), const MInt NotUsed(oldNoCells), const MInt *const NotUsed(bufferIdToCellId), MFloat *const NotUsed(data)) |
virtual void | setCellDataDlb (const MInt NotUsed(dataId), const MInt *const NotUsed(data)) |
virtual void | setCellDataDlb (const MInt NotUsed(dataId), const MLong *const NotUsed(data)) |
virtual void | setCellDataDlb (const MInt NotUsed(dataId), const MFloat *const NotUsed(data)) |
virtual void | getGlobalSolverVars (std::vector< MFloat > &NotUsed(globalFloatVars), std::vector< MInt > &NotUsed(globalIntVars)) |
virtual void | setGlobalSolverVars (std::vector< MFloat > &NotUsed(globalFloatVars), std::vector< MInt > &NotUsed(globalIdVars)) |
void | enableDlbTimers () |
void | reEnableDlbTimers () |
void | disableDlbTimers () |
MBool | dlbTimersEnabled () |
void | startLoadTimer (const MString name) |
void | stopLoadTimer (const MString &name) |
void | stopIdleTimer (const MString &name) |
void | startIdleTimer (const MString &name) |
MBool | isLoadTimerRunning () |
virtual MInt | noSolverTimers (const MBool NotUsed(allTimings)) |
virtual void | getSolverTimings (std::vector< std::pair< MString, MFloat > > &NotUsed(solverTimings), const MBool NotUsed(allTimings)) |
virtual void | getDomainDecompositionInformation (std::vector< std::pair< MString, MInt > > &NotUsed(domainInfo)) |
void | setDlbTimer (const MInt timerId) |
virtual void | prepareAdaptation (std::vector< std::vector< MFloat > > &, std::vector< MFloat > &, std::vector< std::bitset< 64 > > &, std::vector< MInt > &) |
virtual void | reinitAfterAdaptation () |
virtual void | prepareAdaptation () |
prepare adaptation for split adaptation before the adaptation loop More... | |
virtual void | setSensors (std::vector< std::vector< MFloat > > &, std::vector< MFloat > &, std::vector< std::bitset< 64 > > &, std::vector< MInt > &) |
set solver sensors for split adaptation within the adaptation loop More... | |
virtual void | saveSensorData (const std::vector< std::vector< MFloat > > &, const MInt &, const MString &, const MInt *const) |
virtual void | postAdaptation () |
post adaptation for split adaptation within the adaptation loop More... | |
virtual void | finalizeAdaptation () |
finalize adaptation for split sadptation after the adaptation loop More... | |
virtual void | refineCell (const MInt) |
Refine the given cell. More... | |
virtual void | removeChilds (const MInt) |
Coarsen the given cell. More... | |
virtual void | removeCell (const MInt) |
Remove the given cell. More... | |
virtual void | swapCells (const MInt, const MInt) |
Swap the given cells. More... | |
virtual void | swapProxy (const MInt, const MInt) |
Swap the given cells. More... | |
virtual MInt | cellOutside (const MFloat *, const MInt, const MInt) |
Check whether cell is outside the fluid domain. More... | |
virtual void | resizeGridMap () |
Swap the given cells. More... | |
virtual MBool | prepareRestart (MBool, MBool &) |
Prepare the solvers for a grid-restart. More... | |
virtual void | reIntAfterRestart (MBool) |
MPI_Comm | mpiComm () const |
Return the MPI communicator used by this solver. More... | |
virtual MInt | domainId () const |
Return the domainId (rank) More... | |
virtual MInt | noDomains () const |
virtual MBool | isActive () const |
void | setSolverStatus (const MBool status) |
MBool | getSolverStatus () |
Get the solver status indicating if the solver is currently active in the execution recipe. More... | |
MString | testcaseDir () const |
Return the testcase directory. More... | |
MString | outputDir () const |
Return the directory for output files. More... | |
MString | restartDir () const |
Return the directory for restart files. More... | |
MString | solverMethod () const |
Return the solverMethod of this solver. More... | |
MString | solverType () const |
Return the solverType of this solver. More... | |
MInt | restartInterval () const |
Return the restart interval of this solver. More... | |
MInt | restartTimeStep () const |
Return the restart interval of this solver. More... | |
MInt | solverId () const |
Return the solverId. More... | |
MBool | restartFile () |
MInt | readSolverSamplingVarNames (std::vector< MString > &varNames, const MString featureName="") const |
Read sampling variables names, store in vector and return the number of sampling variables. More... | |
virtual MBool | hasRestartTimeStep () const |
virtual MBool | forceAdaptation () |
virtual void | preTimeStep ()=0 |
virtual void | postTimeStep ()=0 |
virtual void | initSolver ()=0 |
virtual void | finalizeInitSolver ()=0 |
virtual void | saveSolverSolution (const MBool NotUsed(forceOutput)=false, const MBool NotUsed(finalTimeStep)=false)=0 |
virtual void | cleanUp ()=0 |
virtual MBool | solutionStep () |
virtual void | preSolutionStep (MInt) |
virtual MBool | postSolutionStep () |
virtual MBool | solverConverged () |
virtual void | getInterpolatedVariables (MInt, const MFloat *, MFloat *) |
virtual void | loadRestartFile () |
virtual MInt | determineRestartTimeStep () const |
virtual void | writeRestartFile (MBool) |
virtual void | writeRestartFile (const MBool, const MBool, const MString, MInt *) |
virtual void | setTimeStep () |
virtual void | implicitTimeStep () |
virtual void | prepareNextTimeStep () |
Static Private Attributes | |
static constexpr const MInt | nDim = 2 |
Definition at line 14 of file fvcartesianapesolver2d.h.
FvApeSolver2D::FvApeSolver2D | ( | MInt | solverId, |
MInt | noSpecies, | ||
MBool * | propertiesGroups, | ||
maia::grid::Proxy< 2 > & | gridProxy_, | ||
Geometry< 2 > & | geometry_, | ||
const MPI_Comm | comm | ||
) |
Definition at line 11 of file fvcartesianapesolver2d.cpp.
|
virtual |
The objective is to encourage the compiler to generate different optimized version depending on the value of m_noSpecies.
Reimplemented from FvCartesianSolverXD< 2, FvSysEqnNS< 2 > >.
Definition at line 25 of file fvcartesianapesolver2d.cpp.
Reimplemented from FvCartesianSolverXD< 2, FvSysEqnNS< 2 > >.
Definition at line 120 of file fvcartesianapesolver2d.cpp.
Definition at line 19 of file fvcartesianapesolver2d.h.
Definition at line 22 of file fvcartesianapesolver2d.h.