Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
DAIrkPimpleFoam Class Reference
Inheritance diagram for DAIrkPimpleFoam:
Inheritance graph
[legend]
Collaboration diagram for DAIrkPimpleFoam:
Collaboration graph
[legend]

Public Member Functions

 TypeName ("DAIrkPimpleFoam")
 
 DAIrkPimpleFoam (char *argsAll, PyObject *pyOptions)
 
virtual ~DAIrkPimpleFoam ()
 
virtual void initSolver ()
 initialize fields and variables More...
 
virtual label solvePrimal ()
 solve the primal equations More...
 
- Public Member Functions inherited from DASolver
 TypeName ("DASolver")
 Runtime type information. More...
 
 declareRunTimeSelectionTable (autoPtr, DASolver, dictionary,(char *argsAll, PyObject *pyOptions),(argsAll, pyOptions))
 
 DASolver (char *argsAll, PyObject *pyOptions)
 
virtual ~DASolver ()
 
virtual label runFPAdj (Vec dFdW, Vec psi)
 solve the adjoint equation using the fixed-point iteration method More...
 
virtual label solveAdjointFP (Vec dFdW, Vec psi)
 solve the adjoint equation using the fixed-point iteration method More...
 
void setTime (scalar time, label timeIndex)
 setTime for OF fields More...
 
label getDdtSchemeOrder ()
 get the ddtScheme order More...
 
void printElapsedTime (const Time &runTime, const label printToScreen)
 
void calcdRdWT (const label isPC, Mat dRdWT)
 compute dRdWT More...
 
void updateKSPPCMat (Mat PCMat, KSP ksp)
 Update the preconditioner matrix for the ksp object. More...
 
label solveLinearEqn (const KSP ksp, const Vec rhsVec, Vec solVec)
 solve the linear equation given a ksp and right-hand-side vector More...
 
void updateOFFields (const scalar *states)
 Update the OpenFOAM field values (including both internal and boundary fields) based on the state array. More...
 
void updateOFMesh (const scalar *volCoords)
 Update the OpenFoam mesh point coordinates based on the volume point coords array. More...
 
void getOFFields (scalar *states)
 assign the state variables from OpenFoam layer to the states array More...
 
void getOFField (const word fieldName, const word fieldType, double *field)
 get a field variable from OF layer More...
 
void getOFMeshPoints (double *points)
 get the flatten mesh points coordinates More...
 
label getInputSize (const word inputName, const word inputType)
 get the array size of an input type More...
 
label getOutputSize (const word outputName, const word outputType)
 get the array size of an output type More...
 
label getInputDistributed (const word inputName, const word inputType)
 get whether the input is distributed among processors More...
 
label getOutputDistributed (const word outputName, const word outputType)
 get whether the output is distributed among processors More...
 
void calcOutput (const word outputName, const word outputType, double *output)
 get whether the output is distributed among processors More...
 
void runColoring ()
 run the coloring solver More...
 
void calcJacTVecProduct (const word inputName, const word inputType, const double *input, const word outputName, const word outputType, const double *seed, double *product)
 calculate the Jacobian-matrix-transposed and vector product for product = [dOutput/dInput]^T * seed More...
 
void setSolverInput (const word inputName, const word inputType, const int inputSize, const double *input, const double *seed)
 
void createMLRKSPMatrixFree (const Mat jacPCMat, KSP ksp)
 create a multi-level, Richardson KSP object with matrix-free Jacobians More...
 
void calcdRdWOldTPsiAD (const label oldTimeLevel, const double *psi, double *dRdWOldTPsi)
 compute dRdWOld^T*Psi More...
 
void calcCouplingFaceCoords (const scalar *volCoords, scalar *surfCoords)
 return the face coordinates based on vol coords More...
 
void getCouplingPatchList (wordList &patchList, word groupName="NONE")
 return the coupling patch list if any scenario is active on couplingInfo dict otherwise return design surface More...
 
void initializedRdWTMatrixFree ()
 initialize matrix free dRdWT More...
 
void destroydRdWTMatrixFree ()
 destroy the matrix free dRdWT More...
 
void registerStateVariableInput4AD (const label oldTimeLevel=0)
 register all state variables as the input for reverse-mode AD More...
 
void deactivateStateVariableInput4AD (const label oldTimeLevel=0)
 deactivate all state variables as the input for reverse-mode AD More...
 
void registerResidualOutput4AD ()
 register all residuals as the output for reverse-mode AD More...
 
void assignVec2ResidualGradient (const double *vecX)
 assign the reverse-mode AD input seeds from vecX to the residuals in OpenFOAM More...
 
void assignStateGradient2Vec (double *vecY, const label oldTimeLevel=0)
 set the reverse-mode AD derivatives from the state variables in OpenFOAM to vecY More...
 
void normalizeGradientVec (double *vecY)
 normalize the reverse-mode AD derivatives stored in vecY More...
 
void normalizeJacTVecProduct (const word inputName, double *product)
 normalize the jacobian vector product that has states as the input such as dFdW and dRdW More...
 
void initializeGlobalADTape4dRdWT ()
 initialize the CoDiPack reverse-mode AD global tape for computing dRdWT*psi More...
 
label hasVolCoordInput ()
 whether the volCoord input is defined More...
 
void initDynamicMesh ()
 resetting internal info in fvMesh, which is needed for multiple primal runs More...
 
label loop (Time &runTime)
 return whether to loop the primal solution, similar to runTime::loop() except we don't do file IO More...
 
void updateInputFieldUnsteady ()
 assign the inputFieldUnsteady values to the OF field vars More...
 
void initInputFieldUnsteady ()
 initialize inputFieldUnsteady from the GlobalVar class More...
 
void meanStatesToStates ()
 assign the mean states values to states More...
 
label getGlobalXvIndex (const label idxPoint, const label idxCoord) const
 basically, we call DAIndex::getGlobalXvIndex More...
 
void writeMatrixBinary (const Mat matIn, const word prefix)
 write the matrix in binary format More...
 
void writeMatrixASCII (const Mat matIn, const word prefix)
 write the matrix in ASCII format More...
 
void readMatrixBinary (Mat matIn, const word prefix)
 read petsc matrix in binary format More...
 
void writeVectorASCII (const Vec vecIn, const word prefix)
 write petsc vector in ascii format More...
 
void readVectorBinary (Vec vecIn, const word prefix)
 read petsc vector in binary format More...
 
void writeVectorBinary (const Vec vecIn, const word prefix)
 write petsc vector in binary format More...
 
label getNLocalAdjointStates () const
 return the number of local adjoint states More...
 
label getNLocalAdjointBoundaryStates () const
 return the number of local adjoint boundary states More...
 
label getNLocalCells () const
 return the number of local cells More...
 
label getNLocalPoints () const
 return the number of local points More...
 
void setDAFunctionList ()
 initialize DASolver::daFunctionPtrList_ one needs to call this before calling printAllFunctions More...
 
void calcAllFunctions (label print=0)
 calculate the values of all objective functions and print them to screen More...
 
double getTimeOpFuncVal (const word functionName)
 get the function value based on timeOp More...
 
label getFunctionListIndex (const word functionName)
 return the index of a give functionName in daFunctionPtrList_ More...
 
label checkMesh () const
 check the mesh quality and return meshOK More...
 
scalar getdFScaling (const word functionName, const label timeIdx)
 get the scaling factor for dF/d? derivative computation More...
 
void printAllOptions ()
 print all DAOption More...
 
void calcPrimalResidualStatistics (const word mode, const label writeRes=0)
 calculate the norms of all residuals and print to screen More...
 
void updateDAOption (PyObject *pyOptions)
 update the allOptions_ dict in DAOption based on the pyOptions from pyDAFoam More...
 
scalar getPrevPrimalSolTime ()
 get the solution time folder for previous primal solution More...
 
void updateBoundaryConditions (const word fieldName, const word fieldType)
 update the boundary condition for a field More...
 
void updateStateBoundaryConditions ()
 update the boundary conditions for all states and intermediate variables More...
 
void calcResiduals (label isPC=0)
 calculate the residuals More...
 
const fvMesh & getMesh ()
 
const Time & getRunTime ()
 return the runTime object More...
 
const DAOptiongetDAOption ()
 get DAOption object More...
 
const DAStateInfogetDAStateInfo ()
 get DAStateInfo object More...
 
const DAIndexgetDAIndex ()
 get DAIndex object More...
 
const DAModelgetDAModel ()
 get DAModel object More...
 
const DAResidualgetDAResidual ()
 get DAResidual object More...
 
const DAFieldgetDAField ()
 get DAField object More...
 
const DALinearEqngetDALinearEqn ()
 get DALinearEqn object More...
 
const DACheckMeshgetDACheckMesh ()
 get DACheckMesh object More...
 
label getNRegressionParameters (word modelName)
 get the number of regression model parameters More...
 
scalar getRegressionParameter (word modelName, const label idxI)
 get the regression parameter More...
 
void setRegressionParameter (word modelName, const label idxI, scalar val)
 set the regression parameter More...
 
void regressionModelCompute ()
 call the compute method of the regression model More...
 
void setPrimalBoundaryConditions (const label printInfo=1)
 update the primal state boundary condition based on the primalBC dict More...
 
void writeFailedMesh ()
 write the failed mesh to disk More...
 
void readStateVars (scalar timeVal, label oldTimeLevel=0)
 read the state variables from the disk and assign the value to the prescribe time level More...
 
void readMeshPoints (const scalar timeVal)
 read the mesh points from the disk and run movePoints to deform the mesh More...
 
void writeMeshPoints (const double *points, const scalar timeVal)
 write the mesh points to the disk for the given timeVal More...
 
void calcPCMatWithFvMatrix (Mat PCMat, const label turbOnly=0)
 calculate the PC mat using fvMatrix More...
 
void initTensorFlowFuncs (pyComputeInterface computeInterface, void *compute, pyJacVecProdInterface jacVecProdInterface, void *jacVecProd, pySetCharInterface setModelNameInterface, void *setModelName)
 initialize tensorflow functions and interfaces for callback More...
 
void writeAdjStates (const label writeMesh, const wordList &additionalOutput)
 write state variables that are NO_WRITE to disk More...
 
scalar getElapsedClockTime ()
 return the elapsed clock time for testing speed More...
 
scalar getElapsedCpuTime ()
 return the elapsed CPU time for testing speed More...
 
template<class classType >
label validateField (const classType &field)
 check if a field variable has nan More...
 
template<class classType >
label validateVectorField (const classType &field)
 check if a field variable has nan More...
 
label validateStates ()
 check if the state variables have valid values More...
 
void getInitStateVals (HashTable< scalar > &initState)
 calculate the initial value for validate states More...
 
void resetStateVals ()
 reset the states to its initial values this usually happens when we have nan in states More...
 
void writeSensMapSurface (const word name, const double *dFdXs, const double *Xs, const label size, const double timeName)
 write the sensitivity map for all wall surfaces More...
 
void writeSensMapField (const word name, const double *dFdField, const word fieldType, const double timeName)
 write the sensitivity map for the entire field More...
 
scalar getLatestTime ()
 get the latest time solution from the case folder. More...
 
void writeAdjointFields (const word function, const double writeTime, const double *psi)
 write the adjoint variables for all states More...
 

Protected Member Functions

tmp< volScalarField > chi (volScalarField &nuTilda, const volScalarField &nu)
 
tmp< volScalarField > fv1 (volScalarField &chi)
 
tmp< volScalarField > fv2 (volScalarField &chi, volScalarField &fv1)
 
tmp< volScalarField > fv3 (volScalarField &chi, volScalarField &fv1)
 
tmp< volScalarField > fw (volScalarField &Stilda, volScalarField &nuTilda, volScalarField &y)
 
tmp< volScalarField > DnuTildaEff (volScalarField &nuTilda, const volScalarField &nu)
 
void correctNut (volScalarField &nut, volScalarField &nuTilda, const volScalarField &nu)
 
void calcPriResIrkOrig (volVectorField &U0, volVectorField &U1, volScalarField &p1, surfaceScalarField &phi1, volScalarField &nuTilda1, volScalarField &nut1, volVectorField &U2, volScalarField &p2, surfaceScalarField &phi2, volScalarField &nuTilda2, volScalarField &nut2, const volScalarField &nu, const scalar &deltaT, volVectorField &U1Res, volScalarField &p1Res, surfaceScalarField &phi1Res, volVectorField &U2Res, volScalarField &p2Res, surfaceScalarField &phi2Res, const scalar &relaxUEqn)
 
void calcPriSAResIrkOrig (volScalarField &nuTilda0, volVectorField &U1, surfaceScalarField &phi1, volScalarField &nuTilda1, volVectorField &U2, surfaceScalarField &phi2, volScalarField &nuTilda2, volScalarField &y, const volScalarField &nu, const scalar &deltaT, volScalarField &nuTilda1Res, volScalarField &nuTilda2Res)
 
void swap (List< scalar > &a, List< scalar > &b)
 
scalar L2norm (const List< scalar > &v)
 
scalar L2norm (const List< scalar > &v, const List< scalar > &V)
 
vector L2norm (const List< vector > &U)
 
vector L2norm (const List< vector > &U, const List< scalar > &V)
 
scalar L2norm (const surfaceScalarField &Phi)
 
scalar L2norm (const surfaceScalarField &Phi, const surfaceScalarField &SfArea)
 
vector getMaxAbs (const List< vector > &U)
 
- Protected Member Functions inherited from DASolver
label isPrintTime (const Time &runTime, const label printInterval) const
 
label checkPrimalFailure ()
 check whether the primal fails based on residual and regression fail flag More...
 
void reduceStateResConLevel (const dictionary &maxResConLv4JacPCMat, HashTable< List< List< word >>> &stateResConInfo) const
 reduce the connectivity level for Jacobian connectivity mat More...
 
void writeAssociatedFields ()
 write associated fields such as relative velocity More...
 

Protected Attributes

scalar D10
 
scalar D11
 
scalar D12
 
scalar D20
 
scalar D21
 
scalar D22
 
scalar w1
 
scalar w2
 
scalar sigmaNut
 
scalar kappa
 
scalar Cb1
 
scalar Cb2
 
scalar Cw1
 
scalar Cw2
 
scalar Cw3
 
scalar Cv1
 
scalar Cv2
 
- Protected Attributes inherited from DASolver
char * argsAll_
 all the arguments More...
 
PyObject * pyOptions_
 all options in DAFoam More...
 
autoPtr< argList > argsPtr_
 args pointer More...
 
autoPtr< Time > runTimePtr_
 runTime pointer More...
 
autoPtr< fvMesh > meshPtr_
 fvMesh pointer More...
 
autoPtr< DAOptiondaOptionPtr_
 DAOption pointer. More...
 
autoPtr< DAModeldaModelPtr_
 DAModel pointer. More...
 
autoPtr< DAIndexdaIndexPtr_
 DAIndex pointer. More...
 
autoPtr< DAFielddaFieldPtr_
 DAField pointer. More...
 
UPtrList< DAFunctiondaFunctionPtrList_
 a list of DAFunction pointers More...
 
UPtrList< DATimeOpdaTimeOpPtrList_
 a list of DATimeOp pointers More...
 
autoPtr< DACheckMeshdaCheckMeshPtr_
 DACheckMesh object pointer. More...
 
autoPtr< DALinearEqndaLinearEqnPtr_
 DALinearEqn pointer. More...
 
autoPtr< DAResidualdaResidualPtr_
 DAResidual pointer. More...
 
autoPtr< DAStateInfodaStateInfoPtr_
 DAStateInfo pointer. More...
 
autoPtr< DARegressiondaRegressionPtr_
 DARegression pointer. More...
 
autoPtr< DAGlobalVardaGlobalVarPtr_
 DAGlobalVar pointer. More...
 
autoPtr< pointField > points0Ptr_
 the initial points for dynamicMesh without volCoord inputs More...
 
HashTable< wordList > stateInfo_
 the stateInfo_ list from DAStateInfo object More...
 
scalar prevPrimalSolTime_ = -1e10
 the solution time for the previous primal solution More...
 
Mat dRdWTMF_
 matrix-free dRdWT matrix used in GMRES solution More...
 
label globalADTape4dRdWTInitialized = 0
 a flag in dRdWTMatVecMultFunction to determine if the global tap is initialized More...
 
scalar primalMinResTol_ = 0.0
 primal residual tolerance More...
 
label printToScreen_ = 0
 whether to print primal information to the screen More...
 
label regModelFail_ = 0
 whether the regModel compute fails More...
 
label printInterval_ = 100
 how frequent do you want to print the primal info default is every 100 steps More...
 
label primalMinIters_ = -1
 primal min number of iterations More...
 
label printIntervalUnsteady_ = 1
 how frequent do you want to print the primal info default is every 100 steps More...
 
List< scalarList > functionTimeSteps_
 a list list that saves the function value for all time steps More...
 
label primalFinalTimeIndex_
 the final time index from the primal solve. for steady state cases it can converge before endTime More...
 
HashTable< scalar > initStateVals_
 initial values for validateStates More...
 

Additional Inherited Members

- Static Public Member Functions inherited from DASolver
static autoPtr< DASolverNew (char *argsAll, PyObject *pyOptions)
 
static PetscErrorCode dRdWTMatVecMultFunction (Mat dRdWT, Vec vecX, Vec vecY)
 matrix free matrix-vector product function to compute vecY=dRdWT*vecX More...
 

Detailed Description

Definition at line 52 of file DAIrkPimpleFoam.H.

Constructor & Destructor Documentation

◆ DAIrkPimpleFoam()

DAIrkPimpleFoam ( char *  argsAll,
PyObject *  pyOptions 
)

Definition at line 41 of file DAIrkPimpleFoam.C.

◆ ~DAIrkPimpleFoam()

virtual ~DAIrkPimpleFoam ( )
inlinevirtual

Definition at line 171 of file DAIrkPimpleFoam.H.

Member Function Documentation

◆ chi()

tmp< volScalarField > chi ( volScalarField &  nuTilda,
const volScalarField &  nu 
)
protected

Definition at line 7 of file mySAModel.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

Here is the caller graph for this function:

◆ fv1()

tmp< volScalarField > fv1 ( volScalarField &  chi)
protected

Definition at line 14 of file mySAModel.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

Here is the caller graph for this function:

◆ fv2()

tmp< volScalarField > fv2 ( volScalarField &  chi,
volScalarField &  fv1 
)
protected

Definition at line 21 of file mySAModel.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

Here is the caller graph for this function:

◆ fv3()

tmp< volScalarField > fv3 ( volScalarField &  chi,
volScalarField &  fv1 
)
protected

Definition at line 28 of file mySAModel.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

Here is the caller graph for this function:

◆ fw()

tmp< volScalarField > fw ( volScalarField &  Stilda,
volScalarField &  nuTilda,
volScalarField &  y 
)
protected

Definition at line 41 of file mySAModel.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

Here is the caller graph for this function:

◆ DnuTildaEff()

tmp< volScalarField > DnuTildaEff ( volScalarField &  nuTilda,
const volScalarField &  nu 
)
protected

Definition at line 62 of file mySAModel.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

Here is the caller graph for this function:

◆ correctNut()

void correctNut ( volScalarField &  nut,
volScalarField &  nuTilda,
const volScalarField &  nu 
)
protected

Definition at line 70 of file mySAModel.H.

Referenced by DAIrkPimpleFoam::calcPriResIrkOrig().

Here is the caller graph for this function:

◆ calcPriResIrkOrig()

void calcPriResIrkOrig ( volVectorField &  U0,
volVectorField &  U1,
volScalarField &  p1,
surfaceScalarField &  phi1,
volScalarField &  nuTilda1,
volScalarField &  nut1,
volVectorField &  U2,
volScalarField &  p2,
surfaceScalarField &  phi2,
volScalarField &  nuTilda2,
volScalarField &  nut2,
const volScalarField &  nu,
const scalar &  deltaT,
volVectorField &  U1Res,
volScalarField &  p1Res,
surfaceScalarField &  phi1Res,
volVectorField &  U2Res,
volScalarField &  p2Res,
surfaceScalarField &  phi2Res,
const scalar &  relaxUEqn 
)
protected

◆ calcPriSAResIrkOrig()

void calcPriSAResIrkOrig ( volScalarField &  nuTilda0,
volVectorField &  U1,
surfaceScalarField &  phi1,
volScalarField &  nuTilda1,
volVectorField &  U2,
surfaceScalarField &  phi2,
volScalarField &  nuTilda2,
volScalarField &  y,
const volScalarField &  nu,
const scalar &  deltaT,
volScalarField &  nuTilda1Res,
volScalarField &  nuTilda2Res 
)
protected

◆ swap()

void swap ( List< scalar > &  a,
List< scalar > &  b 
)
protected

Definition at line 3 of file myUtilities.H.

◆ L2norm() [1/6]

scalar L2norm ( const List< scalar > &  v)
protected

Definition at line 11 of file myUtilities.H.

References forAll().

Referenced by DAIrkPimpleFoam::solvePrimal().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ L2norm() [2/6]

scalar L2norm ( const List< scalar > &  v,
const List< scalar > &  V 
)
protected

Definition at line 24 of file myUtilities.H.

References forAll().

Here is the call graph for this function:

◆ L2norm() [3/6]

vector L2norm ( const List< vector > &  U)
protected

Definition at line 38 of file myUtilities.H.

References forAll(), and U.

Here is the call graph for this function:

◆ L2norm() [4/6]

vector L2norm ( const List< vector > &  U,
const List< scalar > &  V 
)
protected

Definition at line 55 of file myUtilities.H.

References forAll(), and U.

Here is the call graph for this function:

◆ L2norm() [5/6]

scalar L2norm ( const surfaceScalarField &  Phi)
protected

Definition at line 73 of file myUtilities.H.

References forAll().

Here is the call graph for this function:

◆ L2norm() [6/6]

scalar L2norm ( const surfaceScalarField &  Phi,
const surfaceScalarField &  SfArea 
)
protected

Definition at line 93 of file myUtilities.H.

References forAll().

Here is the call graph for this function:

◆ getMaxAbs()

vector getMaxAbs ( const List< vector > &  U)
protected

Definition at line 113 of file myUtilities.H.

References forAll(), and U.

Here is the call graph for this function:

◆ TypeName()

TypeName ( "DAIrkPimpleFoam"  )

◆ initSolver()

void initSolver ( )
virtual

initialize fields and variables

Implements DASolver.

Definition at line 309 of file DAIrkPimpleFoam.C.

References DASolver::daOptionPtr_, DASolver::meshPtr_, and DASolver::pyOptions_.

◆ solvePrimal()

label solvePrimal ( )
virtual

solve the primal equations

Implements DASolver.

Definition at line 318 of file DAIrkPimpleFoam.C.

References args, DASolver::argsPtr_, DAIrkPimpleFoam::calcPriResIrkOrig(), DAIrkPimpleFoam::calcPriSAResIrkOrig(), DAIrkPimpleFoam::L2norm(), mesh, nuTilda1, nuTilda2, p, p1, p2, phi, phi1, phi2, pimple, runTime, U, U1, and U2.

Here is the call graph for this function:

Member Data Documentation

◆ D10

scalar D10
protected

◆ D11

scalar D11
protected

◆ D12

scalar D12
protected

◆ D20

scalar D20
protected

◆ D21

scalar D21
protected

◆ D22

scalar D22
protected

◆ w1

scalar w1
protected

Definition at line 64 of file DAIrkPimpleFoam.H.

◆ w2

scalar w2
protected

Definition at line 65 of file DAIrkPimpleFoam.H.

◆ sigmaNut

scalar sigmaNut
protected

Definition at line 68 of file DAIrkPimpleFoam.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

◆ kappa

scalar kappa
protected

Definition at line 69 of file DAIrkPimpleFoam.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

◆ Cb1

scalar Cb1
protected

Definition at line 70 of file DAIrkPimpleFoam.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

◆ Cb2

scalar Cb2
protected

Definition at line 71 of file DAIrkPimpleFoam.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

◆ Cw1

scalar Cw1
protected

Definition at line 72 of file DAIrkPimpleFoam.H.

Referenced by DAIrkPimpleFoam::calcPriSAResIrkOrig().

◆ Cw2

scalar Cw2
protected

Definition at line 73 of file DAIrkPimpleFoam.H.

◆ Cw3

scalar Cw3
protected

Definition at line 74 of file DAIrkPimpleFoam.H.

◆ Cv1

scalar Cv1
protected

Definition at line 75 of file DAIrkPimpleFoam.H.

◆ Cv2

scalar Cv2
protected

Definition at line 76 of file DAIrkPimpleFoam.H.


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