MAIA bb96820c
Multiphysics at AIA
|
3D structured solver class More...
#include <fvstructuredsolver3d.h>
Public Types | |
typedef void(FvStructuredSolver3D::* | fluxmethod) (MFloat *, MFloat *, MInt, MInt) |
Public Types inherited from FvStructuredSolver< 3 > | |
using | Timers = maia::structured::Timers_ |
Public Member Functions | |
FvStructuredSolver3D (MInt, StructuredGrid< 3 > *, MBool *, const MPI_Comm comm) | |
~FvStructuredSolver3D () | |
void | addGhostPointCoordinateValues () |
Extrapolates and exchanges ghost point coordinates. More... | |
void | extrapolateGhostPointCoordinatesBC () |
void | initSolutionStep (MInt mode) |
void | initialCondition () override |
Computation of infinity values for the conservative and primitive variables. More... | |
void | assignBndryCells () |
void | nonReflectingBC () |
void | applyBoundaryCondition () override |
void | calcSurfaceMetrics () |
void | initBndryCnds () |
void | allocateSingularities () |
void | applySandpaperTrip () |
void | applySandpaperTripAirfoil () |
void | initSandpaperTrip () |
void | tripForceCoefficients (MFloat *, MFloat *, MFloat *, MInt, MInt) |
void | tripFourierCoefficients (MFloat *, MInt, MFloat, MFloat) |
void | computeDomainWidth () override |
void | computeZonalConnections () |
void | zonalExchange () override |
void | zonalAllreduce () |
void | zonalRealInterpolation () |
void | zonalGather () |
void | zonalSend () |
void | zonalReceive () |
void | zonalCheck () |
void | zonalBufferAverage () |
void | zonalScatter () |
void | spanwiseAvgZonal (std::vector< MFloat * > &) override |
void | distributeFluxToCells () |
void | computeTimeStep () override |
void | computeVorticity () override |
void | computeLambda2Criterion () override |
Function to compute the lambda_2 criterion. More... | |
MFloat | computeTotalKineticEngergy () |
MFloat | computeTotalPressure () |
void | initializeNeighbourCellIds () |
void | initFluxMethod () |
void | computePrimitiveVariables () override |
template<MFloat(FvStructuredSolver::*)(MInt) const = &FvStructuredSolver::dummy> | |
void | computePrimitiveVariables_ () |
MFloat | pressure (MInt) |
MFloat | getPSI (MInt, MInt) |
void | Ausm () |
void | AusmLES (MFloat *QLeft, MFloat *QRight, const MInt dim, const MInt cellId) |
AUSM central. More... | |
void | AusmLES_PTHRC (MFloat *QLeft, MFloat *QRight, MInt dim, MInt cellId) |
AUSM PTHRC. More... | |
void | AusmDV (MFloat *QLeft, MFloat *QRight, MInt dim, MInt cellId) |
template<MInt noVars> | |
void | Muscl_AusmLES () |
template<MInt noVars> | |
void | Muscl_AusmLES_PTHRC () |
template<MInt noVars> | |
void | Muscl_AusmDV () |
template<fluxmethod ausm, MInt noVars> | |
void | MusclStretched_ () |
void | Muscl (MInt timerId=-1) override |
void | MusclRANS () |
void | MusclVenkatakrishnan3D () |
MUSCL with Venkatakrishan limiter. More... | |
void | MusclAlbada () |
void | MusclMinModLimiter () |
void | computeCellLength () |
void | computeReconstructionConstantsSVD () |
void | VENKATAKRISHNAN_MOD_FCT (MFloat effNghbrDelta, MFloat srfcDelta, MFloat dxEpsSqr, MInt cellPos, MInt var, MFloatScratchSpace &minPhi) |
Venkatakrishnan limiter, modified for better results. More... | |
void | VENKATAKRISHNAN_FCT (MFloat effNghbrDelta, MFloat srfcDelta, MFloat dxEpsSqr, MInt cellPos, MInt var, MFloatScratchSpace &minPhi) |
Standard Venkatakrishnan limiter. More... | |
void | BARTH_JESPERSON_FCT (MFloat effNghbrDelta, MFloat srfcDelta, MFloat dxEpsSqr, MInt cellPos, MInt var, MFloatScratchSpace &minPhi) |
Barth-Jesperson Limiter. More... | |
MBool | maxResidual () |
Computation of the maximum residual. More... | |
MBool | rungeKuttaStep () |
void | updateSpongeLayer () |
void | addDisturbance () |
void | viscousFlux () |
void | viscousFluxRANS () |
template<MBool twoEqRans = false> | |
void | viscousFluxLES () |
Viscous flux computation. More... | |
void | moveGrid (const MBool isRestart, const MBool zeroPos) override |
void | applyBodyForce (const MBool isRestart, const MBool zeroPos) override |
void | initMovingGrid () override |
void | initBodyForce () override |
void | applyViscousBoundaryCondition () |
void | applyInviscidBoundaryCondition () |
virtual void | computeFrictionPressureCoef (MBool computePower) override |
void | initFFTW (fftw_complex *uPhysField, fftw_complex *vPhysField, fftw_complex *wPhysField, MInt lx, MInt ly, MInt lz, MInt noPeakModes) |
void | getFourierCoefficients (MFloat *k, MFloat k0, std::complex< MFloat > *fourierCoefficient) |
Generates a single complex coefficient of Fourier series. More... | |
MFloat | randnormal (MFloat mu, MFloat sigma) |
Returns a normal distributed random-number with mu=mean and sigma=standard deviation. More... | |
void | loadRestartBC2600 () |
void | loadRestartBC2601 () |
void | loadRestartSTG (MBool) |
void | gather (const MBool, std::vector< std::unique_ptr< StructuredComm< 3 > > > &) override |
void | scatter (const MBool, std::vector< std::unique_ptr< StructuredComm< 3 > > > &) override |
void | waveGather () |
void | waveScatter () |
void | waveSend (std::vector< MPI_Request > &) |
void | waveReceive (std::vector< MPI_Request > &) |
void | waveExchange () override |
void | spanwiseWaveReorder () override |
void | gcFillGhostCells (std::vector< MFloat * > &) |
void | gcExtrapolate (std::vector< MFloat * > &) |
void | viscousFluxCorrection () |
void | computeCumulativeAverage (MBool forceReset) override |
void | initInterpolatedPoints () |
Compute all the interpolation coefficients necessary for the interpolation output. More... | |
void | saveInterpolatedPoints () override |
void | saveNodalBoxes () override |
void | savePointsToAsciiFile (MBool) override |
Saves variables of given cells to ASCII file. More... | |
void | initPointsToAsciiFile () override |
virtual void | computePorousRHS (MBool) override |
void | exchange6002 () |
Public Member Functions inherited from FvStructuredSolver< 3 > | |
FvStructuredSolver (MInt solverId, StructuredGrid< nDim > *, MBool *propertiesGroups, const MPI_Comm comm) | |
Constructor of the structured solver. More... | |
MBool | isActive () const |
void | initializeFQField () |
Counts the number of necessary FQ fields, allocates them and corrects the indexes of the FQ variable pointers. More... | |
MInt | timer (const MInt timerId) const |
MInt | noSolverTimers (const MBool allTimings) override |
virtual void | writeHeaderAttributes (ParallelIoHdf5 *pio, MString fileType) |
Overloaded version of writeHeaderAttributes that receives ParallelIoHdf5 object pointer instead of 'fileId'. More... | |
virtual void | writePropertiesAsAttributes (ParallelIoHdf5 *pio, MString path) |
Overloaded version of writePropertiesAsAttributes that receives ParallelIoHdf5 object pointer instead of 'fileId'. More... | |
void | saveSolverSolution (MBool=false, const MBool=false) override |
void | saveSolution (MBool) |
Saves the soution to hdf5 file. More... | |
void | savePartitions () |
Saves the partitioned grid into an HDF5 file. Not used in production use but useful for debugging. More... | |
void | saveBoxes () |
virtual void | savePointsToAsciiFile (MBool) |
virtual void | initPointsToAsciiFile () |
virtual void | saveInterpolatedPoints () |
virtual void | saveNodalBoxes () |
virtual void | reIntAfterRestart (MBool) |
MBool | prepareRestart (MBool, MBool &) override |
Prepare the solvers for a grid-restart. More... | |
void | writeRestartFile (MBool) override |
void | writeRestartFile (const MBool, const MBool, const MString, MInt *) override |
void | shiftCellValuesRestart (MBool) |
void | loadRestartFile () |
Load Restart File (primitive and conservative output) general formulation. More... | |
MBool | loadBoxFile (MString, MString, MInt, MInt) |
Load Box file general formulation. More... | |
virtual void | loadRestartBC2600 () |
virtual void | loadRestartBC2601 () |
virtual void | loadRestartSTG (MBool) |
void | saveForcesToAsciiFile (MBool) |
Function to save the force coefficients and power to an ASCII file. More... | |
void | saveAveragedVariables (MString, MInt, MFloat **) |
Saves the averaged (mean) variables from postprocessing to an HDF5 file. More... | |
void | saveProductionTerms (MString, MFloat **) |
Writes the production terms into a given file. More... | |
void | saveDissipation (MString, MFloat *) |
Writes the dissipation into a given file. More... | |
void | saveGradients (MString, MFloat **, MString *) |
Writes the gradients into a given file. More... | |
void | saveAverageRestart (MString, MInt, MFloat **, MFloat **, MFloat **, MFloat **) |
Writes an restart file for postprocessing. More... | |
void | getSolverTimings (std::vector< std::pair< MString, MFloat > > &solverTimings, const MBool allTimings) override |
Get solver timings. More... | |
void | getDomainDecompositionInformation (std::vector< std::pair< MString, MInt > > &domainInfo) override |
Return decomposition information, i.e. number of local elements,... More... | |
virtual MFloat | getCellLengthY (MInt, MInt, MInt) |
virtual MFloat | getCellCoordinate (MInt, MInt) |
MInt | noInternalCells () const override |
Return the number of internal cells within this solver. More... | |
void | saveAuxData () |
void | saveForceCoefficient (ParallelIoHdf5 *parallelIoHdf5) |
Saves force coefficients to an HDF5 file. More... | |
void | computeAuxData () |
void | computeAuxDataRoot () |
virtual void | computeDomainWidth () |
void | computeForceCoef () |
Function to compute the force coefficient cl, split split into the viscous part cLv and the pressure part cLp. More... | |
void | computeForceCoefRoot () |
Function to compute the coefficient, split split into the viscous part cLv and the pressure part cLp The ROOT version is faster due to an MPI_Reduce instead of an MPI_Allreduce, but only root rank has data. More... | |
virtual void | computeFrictionPressureCoef (MBool)=0 |
virtual | ~FvStructuredSolver () |
MFloat | computeRecConstSVD (const MInt ijk, const MInt noNghbrIds, MInt *nghbr, MInt ID, MInt sID, MFloatScratchSpace &tmpA, MFloatScratchSpace &tmpC, MFloatScratchSpace &weights, const MInt recDim) |
AUX DATA ENDS /////////////////////////////////////////////////////////////. More... | |
void | initializeFvStructuredSolver (MBool *propertiesGroups) |
Structured Solver Constructor reads and allocate properties/variables. More... | |
void | allocateAndInitBlockMemory () |
void | allocateAuxDataMaps () |
AUX DATA //////////////////////////////////////////////////////////////////. More... | |
void | setRungeKuttaProperties () |
This function reads the properties required for Runge Kutta time stepping. More... | |
void | setSamplingProperties () |
void | setNumericalProperties () |
Reads and initializes properties associated with the numerical method. More... | |
void | setInputOutputProperties () |
Reads properties and initializes variables associated with input/output. More... | |
void | setZonalProperties () |
Set which zones are RANS and which are LES or if full LES or full RANS. More... | |
void | allocateVariables () |
void | setTestcaseProperties () |
Reads and initializes properties associated with the Testcase. More... | |
void | setMovingGridProperties () |
Reads and initializes properties associated with the Moving Grid Methods. More... | |
void | setBodyForceProperties () |
Reads and initializes properties associated with the Moving Grid Methods. More... | |
void | setPorousProperties () |
Set properties for porous blocks. More... | |
void | readAndSetSpongeLayerProperties () |
void | setSTGProperties () |
void | setProfileBCProperties () |
void | createMPIGroups () |
void | readAndSetAuxDataMap () |
void | computePV () |
MFloat | dummy (MInt) const |
MFloat | pressure_twoEqRans (MInt cellId) const |
MFloat | totalEnergy_twoEqRans (MInt cellId) const |
void | partitionGrid () |
virtual void | computePrimitiveVariables () |
virtual void | computeConservativeVariables () |
void | computeConservativeVariables_ () |
void | saveVarToPrimitive (MInt, MInt, MFloat) |
virtual void | gcFillGhostCells (std::vector< MFloat * > &) |
void | computeSamplingInterval () |
void | checkNans () |
Checks whole domain for NaNs and adds the number of NaNs globally. More... | |
void | setVolumeForce () |
void | computeVolumeForces () |
virtual void | computePorousRHS (MBool) |
void | initPorous () |
virtual void | applyBoundaryCondtition () |
virtual void | moveGrid (MInt) |
virtual void | moveGrid (MBool, MBool) |
virtual void | initMovingGrid () |
virtual void | initBodyForce () |
virtual void | applyBodyForce (MBool, MBool) |
virtual void | computeLambda2Criterion () |
virtual void | computeVorticity () |
void | exchange () |
SVD STUFF ENDS /////////////////////////////////////////////////////////////. More... | |
void | exchange (std::vector< std::unique_ptr< StructuredComm< nDim > > > &, std::vector< std::unique_ptr< StructuredComm< nDim > > > &) |
Parallel exchange of primitive variables between partitions with MPI. More... | |
void | send (const MBool, std::vector< std::unique_ptr< StructuredComm< nDim > > > &, std::vector< MPI_Request > &) |
void | receive (const MBool, std::vector< std::unique_ptr< StructuredComm< nDim > > > &, std::vector< MPI_Request > &) |
virtual void | gather (const MBool, std::vector< std::unique_ptr< StructuredComm< nDim > > > &) |
virtual void | scatter (const MBool, std::vector< std::unique_ptr< StructuredComm< nDim > > > &) |
MBool | isPeriodicComm (std::unique_ptr< StructuredComm< nDim > > &) |
MBool | skipPeriodicDirection (std::unique_ptr< StructuredComm< nDim > > &) |
virtual void | zonalExchange () |
virtual void | spanwiseAvgZonal (std::vector< MFloat * > &) |
virtual void | waveExchange () |
virtual void | spanwiseWaveReorder () |
void | setTimeStep () |
void | setLimiterVisc () |
void | fixTimeStepTravelingWave () |
void | exchangeTimeStep () |
void | initializeRungeKutta () |
virtual void | computeTimeStep () |
MBool | isInInterval (MInt) |
MInt | getNoCells () |
MInt | noVariables () const override |
Return the number of variables. More... | |
MInt | getNoActiveCells () |
MInt * | getActiveCells () |
MInt * | getOffsetCells () |
MInt | getNoGhostLayers () |
MInt | getWaveAvrgInterval () |
MInt | getWaveStepOffset () |
MInt * | getCellGrid () |
MBool | isMovingGrid () |
MInt | getGridMovingMethod () |
MInt | getBodyForceMethod () |
MBool | isStreamwiseTravelingWave () |
MBool | isTravelingWave () |
StructuredGrid< nDim > * | getGrid () |
MFloat | getGamma () |
MFloat | getSutherlandConstant () |
MFloat | getRe0 () |
MFloat | getMa () |
MPI_Comm | getCommunicator () |
virtual void | computeCumulativeAverage (MBool) |
virtual void | loadSampleFile (MString) |
virtual void | getSampleVariables (MInt, MFloat *) |
MFloat | getPV (MInt var, MInt cellId) |
void | setPV (MInt var, MInt cellId, MFloat value) |
virtual MFloat | getSampleVorticity (MInt, MInt) |
virtual MFloat | dvardxyz (MInt, MInt, MFloat *) |
virtual MFloat | dvardx (MInt, MFloat *) |
virtual void | loadAverageRestartFile (const char *, MFloat **, MFloat **, MFloat **, MFloat **) |
virtual void | loadAveragedVariables (const char *) |
void | convertRestartVariables (MFloat oldMa) |
virtual void | convertRestartVariablesSTG (MFloat oldMa) |
virtual bool | rungeKuttaStep ()=0 |
virtual void | viscousFlux ()=0 |
virtual void | Muscl (MInt=-1)=0 |
virtual void | applyBoundaryCondition ()=0 |
virtual void | initSolutionStep (MInt)=0 |
virtual void | initialCondition ()=0 |
void | tred2 (MFloatScratchSpace &A, MInt dim, MFloat *diag, MFloat *offdiag) |
Householder Reduction according to Numercial Recipies in C: The Art of Scientific Computing. More... | |
void | tqli2 (MFloat *diag, MFloat *offdiag, MInt dim) |
Compute Eigenvalues with implicit shift according to Numercial Recipies in C: The Art of Scientific Computing. More... | |
void | insertSort (MInt dim, MFloat *list) |
Sorting function to sort list in ascending order. More... | |
MFloat | pythag (MFloat a, MFloat b) |
void | resetRHS () |
Reset the right hand side to zero. More... | |
void | rhs () |
void | rhsBnd () |
void | lhsBnd () |
void | initSolver () override |
virtual MBool | maxResidual () |
MBool | solutionStep () override |
void | preTimeStep () override |
void | postTimeStep () override |
: Performs the post time step More... | |
void | finalizeInitSolver () override |
void | cleanUp () override |
virtual void | updateSpongeLayer ()=0 |
MFloat | time () const override |
Return the time. More... | |
MInt | determineRestartTimeStep () const override |
Load the restart time step from the restart file (useNonSpecifiedRestartFile enabled) More... | |
MBool | hasRestartTimeStep () const override |
void | init () |
std::array< MInt, nDim > | beginP0 () |
std::array< MInt, nDim > | beginP1 () |
std::array< MInt, nDim > | beginP2 () |
std::array< MInt, nDim > | endM2 () |
std::array< MInt, nDim > | endM1 () |
std::array< MInt, nDim > | endM0 () |
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 () |
Public Member Functions inherited from StructuredPostprocessing< nDim, FvStructuredSolver< nDim > > | |
StructuredPostprocessing () | |
Constructor for the postprocessing solver. More... | |
~StructuredPostprocessing () | |
Destructor for the postprocessing solver. More... | |
void | postprocessPreInit () |
void | postprocessPreSolve () |
void | postprocessPostSolve () |
void | postprocessInSolve () |
Public Attributes | |
std::vector< std::unique_ptr< StructuredZonalBC > > | m_zonalBC |
void(FvStructuredSolver3D::* | reconstructSurfaceData )() |
void(FvStructuredSolver3D::* | Venkatakrishnan_function )(MFloat, MFloat, MFloat, MInt, MInt, MFloatScratchSpace &) |
void(FvStructuredSolver3D::* | viscFluxMethod )() |
Public Attributes inherited from FvStructuredSolver< 3 > | |
StructuredGrid< nDim > * | m_grid |
MPI_Comm | m_StructuredComm |
MInt | m_restartTimeStep |
MString | m_outputFormat |
MInt | m_lastOutputTimeStep |
Public Attributes inherited from Solver | |
std::set< MInt > | m_freeIndices |
MBool | m_singleAdaptation = false |
MBool | m_splitAdaptation = true |
MBool | m_saveSensorData = false |
Public Attributes inherited from StructuredPostprocessing< nDim, FvStructuredSolver< nDim > > | |
MInt | m_restartTimeStep |
Protected Member Functions | |
void | crossProduct (MFloat *, const MFloat *, const MFloat *) |
MInt | cellIndex (const MInt, const MInt, const MInt) |
MInt | pointIndex (const MInt, const MInt, const MInt) |
MFloat | dist (MFloat *a, MFloat *b) |
MInt | getPointIdFromCell (const MInt, const MInt, const MInt) |
MInt | getPointIdfromPoint (const MInt, const MInt, const MInt, const MInt) |
MInt | getCellIdfromCell (const MInt, const MInt, const MInt, const MInt) |
MInt | surfId (MInt point, MInt isd, MInt dim) |
void | manualInterpolationCorrection () |
Manually correct errors made by the restart interpolation. More... | |
void | interpolateFromDonor () |
Interpolates the flow field from a given donor file. More... | |
void | loadSampleFile (MString) override |
Loads primitive variables from an HDF5 file. More... | |
void | getSampleVariables (MInt, MFloat *) override |
MFloat | getSampleVorticity (MInt, MInt) override |
void | loadAverageRestartFile (const MChar *, MFloat **, MFloat **, MFloat **, MFloat **) override |
Loads the postprocessing restart file to continue the postprocessing. More... | |
void | loadAveragedVariables (const MChar *) override |
Loads the averaged variables again to do further postprocessing. More... | |
void | shiftAverageCellValuesRestart () |
void | shiftAverageCellValues () |
Shifts the averaged variables. More... | |
MFloat | dvardxyz (MInt, MInt, MFloat *) override |
MFloat | dvardx (MInt, MFloat *) override |
MFloat | getCellLengthY (MInt, MInt, MInt) override |
MFloat | getCellCoordinate (MInt, MInt) override |
Protected Member Functions inherited from FvStructuredSolver< 3 > | |
void | initTimers () |
virtual void | initFsc () |
Init for Falkner-Skan-Cooke flow. More... | |
virtual MFloat | getFscPressure (MInt cellId) |
virtual MFloat | getFscPressure (MFloat coordX) |
virtual MFloat | getFscEta (MFloat coordX, MFloat coordY) |
virtual void | getFscVelocity (MInt cellId, MFloat *const vel) |
Load variables for the specified timeStep. More... | |
virtual void | getFscVelocity (MFloat coordX, MFloat coordY, MFloat *const vel) |
virtual void | initBlasius () |
Init for Blasius boundary layer. More... | |
virtual MFloat | getBlasiusEta (MFloat coordX, MFloat coordY) |
virtual void | getBlasiusVelocity (MInt cellId, MFloat *const vel) |
Load variables for the specified timeStep. More... | |
virtual void | getBlasiusVelocity (MFloat coordX, MFloat coordY, MFloat *const vel) |
Protected Member Functions inherited from Solver | |
Solver (const MInt solverId, const MPI_Comm comm, const MBool isActive=true) | |
MFloat | returnLoadRecord () const |
MFloat | returnIdleRecord () const |
Protected Member Functions inherited from StructuredPostprocessing< nDim, FvStructuredSolver< nDim > > | |
void | initStructuredPostprocessing () |
void | initAverageIn () |
Initializes properties for averaging during solver run. More... | |
void | initAverageVariables () |
allocates memory for averageSolutions() and averageSolutionsInSolve() More... | |
void | initTimeStepProperties () |
Initializes timestep properties for postprocessing. More... | |
void | initMovingAverage () |
void | initProductionVariables () |
void | initDissipationVariables () |
void | averageSolutionsInSolve () |
void | averageSolutions () |
void | addAveragingSample () |
Adds one sample to the summedVars. More... | |
void | addTempWaveSample () |
Adds for the travelling wave setups. More... | |
void | saveAveragedSolution (MInt) |
void | computeAveragedSolution () |
Computes the mean variables from summed vars. More... | |
void | computeAverageSkinFriction () |
Computes skin friction of an averaged field. More... | |
void | subtractPeriodicFluctuations () |
void | subtractMean () |
void | movingAverage () |
void | movingAveragePost () |
void | computeProductionTerms () |
Computes the production terms from an averaged field. More... | |
void | computeDissipationTerms () |
Computes the production terms from an averaged field. More... | |
void | decomposeCf () |
void | decomposeCfDouble () |
void | writeGradients () |
void | loadAveragedSolution () |
Loads an averaged file again. More... | |
void | saveAverageRestart () |
void | loadMeanFile (const MChar *fileName) |
void | getSampleVariables (MInt cellId, const MFloat *&vars) |
MInt | getNoPPVars () |
Returns number of postprocessing variables. More... | |
MInt | getNoVars () |
MInt | getNoPPSquareVars () |
Returns number of pp Square variables. More... | |
Static Protected Attributes | |
static constexpr MInt | xsd = 0 |
static constexpr MInt | ysd = 1 |
static constexpr MInt | zsd = 2 |
static constexpr const MInt | nDim = 3 |
Static Protected Attributes inherited from StructuredPostprocessing< nDim, FvStructuredSolver< nDim > > | |
static const MInt | xsd |
static const MInt | ysd |
static const MInt | zsd |
Friends | |
template<MBool isRans> | |
class | StructuredBndryCnd3D |
class | FvStructuredSolver3DRans |
Additional Inherited Members | |
Protected Types inherited from StructuredPostprocessing< nDim, FvStructuredSolver< nDim > > | |
typedef void(StructuredPostprocessing::* | tpost) () |
typedef std::vector< tpost > | tvecpost |
Definition at line 32 of file fvstructuredsolver3d.h.
typedef void(FvStructuredSolver3D::* FvStructuredSolver3D::fluxmethod) (MFloat *, MFloat *, MInt, MInt) |
Definition at line 91 of file fvstructuredsolver3d.h.
FvStructuredSolver3D::FvStructuredSolver3D | ( | MInt | solverId, |
StructuredGrid< 3 > * | grid_, | ||
MBool * | propertiesGroups, | ||
const MPI_Comm | comm | ||
) |
Definition at line 17 of file fvstructuredsolver3d.cpp.
FvStructuredSolver3D::~FvStructuredSolver3D | ( | ) |
Definition at line 103 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::addDisturbance | ( | ) |
Definition at line 4524 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::addGhostPointCoordinateValues | ( | ) |
Definition at line 4583 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::allocateSingularities | ( | ) |
Definition at line 9711 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 7863 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Implements FvStructuredSolver< 3 >.
Definition at line 2274 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::applyInviscidBoundaryCondition | ( | ) |
Definition at line 9369 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::applySandpaperTrip | ( | ) |
Definition at line 4077 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::applySandpaperTripAirfoil | ( | ) |
Definition at line 4135 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::applyViscousBoundaryCondition | ( | ) |
Definition at line 9371 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::assignBndryCells | ( | ) |
Definition at line 4569 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::Ausm | ( | ) |
Definition at line 3689 of file fvstructuredsolver3d.cpp.
Definition at line 2863 of file fvstructuredsolver3d.cpp.
|
inline |
Can be used for moving grids, dxt term is included
Definition at line 2692 of file fvstructuredsolver3d.cpp.
|
inline |
Same AUSM scheme as AusmLES with additional damping controlled by the 4th order pressure derivative. Pressure needs to computed beforehand.
Definition at line 2771 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::BARTH_JESPERSON_FCT | ( | MFloat | effNghbrDelta, |
MFloat | srfcDelta, | ||
MFloat | dxEpsSqr, | ||
MInt | cellPos, | ||
MInt | var, | ||
MFloatScratchSpace & | minPhi | ||
) |
Definition at line 2677 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::calcSurfaceMetrics | ( | ) |
Definition at line 4998 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::computeCellLength | ( | ) |
Definition at line 866 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
do the time average of the flow variables for LES and store them.
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 4267 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 3693 of file fvstructuredsolver3d.cpp.
|
inlineoverridevirtual |
Implements FvStructuredSolver< 3 >.
Definition at line 138 of file fvstructuredsolver3d.h.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9162 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 5501 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9703 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::computePrimitiveVariables_ |
Definition at line 9669 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::computeReconstructionConstantsSVD | ( | ) |
Definition at line 9941 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 4348 of file fvstructuredsolver3d.cpp.
MFloat FvStructuredSolver3D::computeTotalKineticEngergy | ( | ) |
Definition at line 5749 of file fvstructuredsolver3d.cpp.
MFloat FvStructuredSolver3D::computeTotalPressure | ( | ) |
Definition at line 5765 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9093 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::computeZonalConnections | ( | ) |
Definition at line 105 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::distributeFluxToCells | ( | ) |
Definition at line 4265 of file fvstructuredsolver3d.cpp.
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9435 of file fvstructuredsolver3d.cpp.
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9414 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::exchange6002 | ( | ) |
GATHER & SEND
RECEIVE
WAIT
SCATTER
Definition at line 10043 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::extrapolateGhostPointCoordinatesBC | ( | ) |
Definition at line 4621 of file fvstructuredsolver3d.cpp.
|
override |
Definition at line 4684 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::gcExtrapolate | ( | std::vector< MFloat * > & | variables | ) |
Definition at line 4910 of file fvstructuredsolver3d.cpp.
|
virtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 4898 of file fvstructuredsolver3d.cpp.
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 975 of file fvstructuredsolver3d.cpp.
|
inlineprotected |
Definition at line 5002 of file fvstructuredsolver3d.cpp.
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 955 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::getFourierCoefficients | ( | MFloat * | k, |
MFloat | k0, | ||
std::complex< MFloat > * | fourierCoefficient | ||
) |
Original Implementation by Georg Eitel Amor for a given wavenumber k, and a certain energy spectrum (see Appendix of Orszag, 1969)
Definition at line 9880 of file fvstructuredsolver3d.cpp.
|
inlineprotected |
Definition at line 5788 of file fvstructuredsolver3d.cpp.
|
inlineprotected |
Definition at line 5792 of file fvstructuredsolver3d.cpp.
Definition at line 10524 of file fvstructuredsolver3d.cpp.
|
overrideprotectedvirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9373 of file fvstructuredsolver3d.cpp.
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9381 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::initBndryCnds | ( | ) |
Definition at line 4574 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 8044 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::initFFTW | ( | fftw_complex * | uPhysField, |
fftw_complex * | vPhysField, | ||
fftw_complex * | wPhysField, | ||
MInt | lx, | ||
MInt | ly, | ||
MInt | lz, | ||
MInt | noPeakModes | ||
) |
Definition at line 9732 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::initFluxMethod | ( | ) |
Definition at line 674 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Initialization ot the entire flow field
Implements FvStructuredSolver< 3 >.
Definition at line 1112 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::initializeNeighbourCellIds | ( | ) |
void FvStructuredSolver3D::initInterpolatedPoints | ( | ) |
Definition at line 2063 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 6492 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 2077 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::initSandpaperTrip | ( | ) |
Definition at line 3741 of file fvstructuredsolver3d.cpp.
|
virtual |
Implements FvStructuredSolver< 3 >.
Definition at line 978 of file fvstructuredsolver3d.cpp.
|
protected |
Instead of a restart from a restart file this method will interpolate from a donor solution onto the flow field
Definition at line 1058 of file fvstructuredsolver3d.cpp.
|
overrideprotectedvirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9546 of file fvstructuredsolver3d.cpp.
|
overrideprotectedvirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9464 of file fvstructuredsolver3d.cpp.
|
virtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 8617 of file fvstructuredsolver3d.cpp.
|
virtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 8737 of file fvstructuredsolver3d.cpp.
|
virtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 8845 of file fvstructuredsolver3d.cpp.
|
overrideprotectedvirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9393 of file fvstructuredsolver3d.cpp.
|
protected |
In case some cells did not get correct values in the interpolation process (due to no matching donor cells) Put your routines that will correct these cells here.
Definition at line 2190 of file fvstructuredsolver3d.cpp.
|
virtual |
This function computes the maxResidual using Res = deltaT/(CFL*VolOfCell) * |RHS|
with deltaT depending on local or global time stepping is used. checks if the computed max density residual is below the convergence criterion and returns boolean variable
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 5554 of file fvstructuredsolver3d.cpp.
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 5798 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Implements FvStructuredSolver< 3 >.
Definition at line 3646 of file fvstructuredsolver3d.cpp.
template void FvStructuredSolver3D::Muscl_AusmDV< 7 > | ( | ) |
Definition at line 3330 of file fvstructuredsolver3d.cpp.
template void FvStructuredSolver3D::Muscl_AusmLES< 7 > | ( | ) |
Definition at line 2980 of file fvstructuredsolver3d.cpp.
template void FvStructuredSolver3D::Muscl_AusmLES_PTHRC< 7 > | ( | ) |
Definition at line 3124 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::MusclAlbada | ( | ) |
Definition at line 2360 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::MusclMinModLimiter | ( | ) |
Definition at line 2284 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::MusclRANS | ( | ) |
Definition at line 2281 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::MusclStretched_ |
Definition at line 3556 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::MusclVenkatakrishnan3D | ( | ) |
Here, MUSCL and AUSM are run through separately The values of QLeft and QRight (of every cell) from the MUSCL are stored in the scratchspace before passing it to the AUSM scheme. Pros: the limiter can include the values of the neighbouring cells, better results for waves Cons: higher computational effort
Definition at line 2452 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::nonReflectingBC | ( | ) |
Definition at line 2269 of file fvstructuredsolver3d.cpp.
Definition at line 5007 of file fvstructuredsolver3d.cpp.
Definition at line 5779 of file fvstructuredsolver3d.cpp.
Definition at line 2233 of file fvstructuredsolver3d.cpp.
|
virtual |
Implements FvStructuredSolver< 3 >.
Definition at line 4418 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 9253 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 8424 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 2107 of file fvstructuredsolver3d.cpp.
|
override |
Definition at line 4711 of file fvstructuredsolver3d.cpp.
|
protected |
Definition at line 9636 of file fvstructuredsolver3d.cpp.
|
protected |
Definition at line 9580 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 4303 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 4872 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::tripForceCoefficients | ( | MFloat * | modes, |
MFloat * | forceCoef, | ||
MFloat * | coords, | ||
MInt | noCells, | ||
MInt | noModes | ||
) |
Definition at line 4214 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::tripFourierCoefficients | ( | MFloat * | modes, |
MInt | noModes, | ||
MFloat | maxWaveLength, | ||
MFloat | minWaveLength | ||
) |
Definition at line 4246 of file fvstructuredsolver3d.cpp.
|
virtual |
Implements FvStructuredSolver< 3 >.
Definition at line 4412 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::VENKATAKRISHNAN_FCT | ( | MFloat | effNghbrDelta, |
MFloat | srfcDelta, | ||
MFloat | dxEpsSqr, | ||
MInt | cellPos, | ||
MInt | var, | ||
MFloatScratchSpace & | minPhi | ||
) |
Definition at line 2664 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::VENKATAKRISHNAN_MOD_FCT | ( | MFloat | effNghbrDelta, |
MFloat | srfcDelta, | ||
MFloat | dxEpsSqr, | ||
MInt | cellPos, | ||
MInt | var, | ||
MFloatScratchSpace & | minPhi | ||
) |
Definition at line 2652 of file fvstructuredsolver3d.cpp.
|
virtual |
Implements FvStructuredSolver< 3 >.
Definition at line 5012 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::viscousFluxCorrection | ( | ) |
Definition at line 5308 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::viscousFluxLES |
Definition at line 5020 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::viscousFluxRANS | ( | ) |
Definition at line 5014 of file fvstructuredsolver3d.cpp.
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 4765 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::waveGather | ( | ) |
Definition at line 4786 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::waveReceive | ( | std::vector< MPI_Request > & | rcvRequests | ) |
Definition at line 4829 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::waveScatter | ( | ) |
Definition at line 4840 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::waveSend | ( | std::vector< MPI_Request > & | sndRequests | ) |
Definition at line 4818 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::zonalAllreduce | ( | ) |
void FvStructuredSolver3D::zonalBufferAverage | ( | ) |
void FvStructuredSolver3D::zonalCheck | ( | ) |
|
overridevirtual |
Reimplemented from FvStructuredSolver< 3 >.
Definition at line 546 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::zonalGather | ( | ) |
Definition at line 554 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::zonalRealInterpolation | ( | ) |
void FvStructuredSolver3D::zonalReceive | ( | ) |
Definition at line 613 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::zonalScatter | ( | ) |
Definition at line 632 of file fvstructuredsolver3d.cpp.
void FvStructuredSolver3D::zonalSend | ( | ) |
Definition at line 597 of file fvstructuredsolver3d.cpp.
|
friend |
Definition at line 35 of file fvstructuredsolver3d.h.
|
friend |
Definition at line 34 of file fvstructuredsolver3d.h.
|
protected |
Definition at line 190 of file fvstructuredsolver3d.h.
|
protected |
Definition at line 208 of file fvstructuredsolver3d.h.
|
protected |
Definition at line 203 of file fvstructuredsolver3d.h.
|
protected |
Definition at line 183 of file fvstructuredsolver3d.h.
|
protected |
Definition at line 207 of file fvstructuredsolver3d.h.
std::vector<std::unique_ptr<StructuredZonalBC> > FvStructuredSolver3D::m_zonalBC |
Definition at line 69 of file fvstructuredsolver3d.h.
|
staticconstexprprotected |
Definition at line 227 of file fvstructuredsolver3d.h.
void(FvStructuredSolver3D::* FvStructuredSolver3D::reconstructSurfaceData) () |
Definition at line 103 of file fvstructuredsolver3d.h.
void(FvStructuredSolver3D::* FvStructuredSolver3D::Venkatakrishnan_function) (MFloat, MFloat, MFloat, MInt, MInt, MFloatScratchSpace &) |
Definition at line 119 of file fvstructuredsolver3d.h.
void(FvStructuredSolver3D::* FvStructuredSolver3D::viscFluxMethod) () |
Definition at line 129 of file fvstructuredsolver3d.h.
|
staticconstexprprotected |
Definition at line 186 of file fvstructuredsolver3d.h.
|
staticconstexprprotected |
Definition at line 187 of file fvstructuredsolver3d.h.
|
staticconstexprprotected |
Definition at line 188 of file fvstructuredsolver3d.h.