Public Types | Public Member Functions | Static Public Member Functions | List of all members
tmp Class Reference

A class for managing temporary objects. More...

Inheritance diagram for tmp:
Inheritance graph
[legend]

Public Types

typedef T element_type
 
typedef Tpointer
 
typedef Foam::refCount refCount
 

Public Member Functions

constexpr tmp () noexcept
 
constexpr tmp (std::nullptr_t) noexcept
 
 tmp (T *p)
 
constexpr tmp (const T &obj) noexcept
 
 tmp (tmp< T > &&rhs) noexcept
 
 tmp (const tmp< T > &&rhs) noexcept
 
 tmp (const tmp< T > &rhs)
 
 tmp (const tmp< T > &rhs, bool reuse)
 
 ~tmp ()
 
bool good () const noexcept
 
bool is_const () const noexcept
 
bool is_pointer () const noexcept
 
bool movable () const noexcept
 
Tget () noexcept
 
const Tget () const noexcept
 
const Tcref () const
 
Tref () const
 
TconstCast () const
 
Tptr () const
 
void clear () const noexcept
 
void reset (tmp< T > &&other) noexcept
 
void reset (T *p=nullptr) noexcept
 
void cref (const tmp< T > &other) noexcept
 
void cref (const T &obj) noexcept
 
void cref (const T *p) noexcept
 
void ref (T &obj) noexcept
 
void ref (T *p) noexcept
 
void swap (tmp< T > &other) noexcept
 
const Toperator-> () const
 
Toperator-> ()
 
const Toperator() () const
 
 operator bool () const noexcept
 
 operator const T & () const
 
void operator= (const tmp< T > &other)
 
void operator= (tmp< T > &&other) noexcept
 
void operator= (T *p)
 
void operator= (std::nullptr_t) noexcept
 
bool valid () const noexcept
 
bool isTmp () const noexcept
 
bool empty () const noexcept
 
template<class... Args>
Foam::tmp< TNew (Args &&... args)
 
template<class U , class... Args>
Foam::tmp< TNewFrom (Args &&... args)
 

Static Public Member Functions

template<class... Args>
static tmp< TNew (Args &&... args)
 
template<class U , class... Args>
static tmp< TNewFrom (Args &&... args)
 
static word typeName ()
 

Detailed Description

A class for managing temporary objects.

This is a combination of std::shared_ptr (with intrusive ref-counting) and a shared_ptr without ref-counting and null deleter. This allows the tmp to double as a pointer management and an indirect pointer to externally allocated objects.

Source files
See also
Foam::autoPtr Foam::refPtr Foam::refCount

Definition at line 57 of file PtrList.H.

Member Typedef Documentation

◆ element_type

typedef T element_type

Definition at line 91 of file tmp.H.

◆ pointer

typedef T* pointer

Definition at line 94 of file tmp.H.

◆ refCount

Definition at line 98 of file tmp.H.

Constructor & Destructor Documentation

◆ tmp() [1/8]

constexpr tmp ( )
inlineconstexprnoexcept

◆ tmp() [2/8]

constexpr tmp ( std::nullptr_t  )
inlineconstexprnoexcept

◆ tmp() [3/8]

tmp ( T p)
inlineexplicit

Definition at line 87 of file tmpI.H.

◆ tmp() [4/8]

constexpr tmp ( const T obj)
inlineconstexprnoexcept

◆ tmp() [5/8]

tmp ( tmp< T > &&  rhs)
inlinenoexcept

◆ tmp() [6/8]

tmp ( const tmp< T > &&  rhs)
inlinenoexcept

◆ tmp() [7/8]

tmp ( const tmp< T > &  rhs)
inline

Definition at line 134 of file tmpI.H.

◆ tmp() [8/8]

tmp ( const tmp< T > &  rhs,
bool  reuse 
)
inline

Definition at line 157 of file tmpI.H.

◆ ~tmp()

~tmp ( )
inline

Definition at line 190 of file tmpI.H.

Member Function Documentation

◆ New() [1/2]

static tmp<T> New ( Args &&...  args)
inlinestatic

Referenced by solidAbsorption::a(), viscousDissipation::addSup(), interRegionHeatTransferModel::addSup(), adjointLaminar::adjointMeanFlowSource(), boundaryAdjointContribution::adjointTMVariable1Source(), boundaryAdjointContribution::adjointTMVariable2Source(), acousticWaveTransmissiveFvPatchField< Type >::advectionSpeed(), GAMGInterface::agglomerateCoeffs(), variablesSet::autoCreateMeshMovementField(), kOmegaSSTBase< eddyViscosity< RASModel< BasicTurbulenceModel > > >::beta(), blendingFactor::blendingFactor(), alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField::calcAlphat(), nutLowReWallFunctionFvPatchScalarField::calcNut(), atmNutUWallFunctionFvPatchScalarField::calcNut(), atmNutkWallFunctionFvPatchScalarField::calcNut(), atmNutWallFunctionFvPatchScalarField::calcNut(), deltaBoundary::cellCenters_d(), fvPatch::Cn(), adjointEikonalSolver::computeYPhi(), searchablePlane::coordinates(), searchableBox::coordinates(), searchableDisk::coordinates(), searchablePlate::coordinates(), searchableCylinder::coordinates(), searchableSurfaceCollection::coordinates(), searchableCone::coordinates(), triSurfaceMesh::coordinates(), searchableSphere::coordinates(), NURBS3DVolume::coordinates(), twoPhaseMixtureEThermo::Cp(), twoPhaseMixtureThermo::Cp(), multiphaseMixtureThermo::Cp(), phaseSystem::Cp(), displacementMeshMoverMotionSolver::curPoints(), triSurfaceTools::curvatures(), filmTurbulenceModel::Cw(), MRFZoneList::DDt(), cyclicFaPatch::delta(), cyclicACMIFvPatch::delta(), cyclicAMIFvPatch::delta(), DESModelRegions::DESModelRegions(), RASModelVariables::devReff(), adjointSpalartAllmaras::devReff(), adjointRASModel::diffusionCoeffVar1(), adjointRASModel::diffusionCoeffVar2(), adjointLaminar::distanceSensitivities(), momentumError::divDevRhoReff(), kL< BasicTurbulenceModel >::DkEff(), Bezier::dndbBasedSensitivities(), SpalartAllmaras< BasicTurbulenceModel >::DnuTildaEff(), kEpsilonPhitF< BasicTurbulenceModel >::DphitEff(), multiphaseMangrovesSource::dragCoeff(), surfactantProperties::dSigma(), Bezier::dxdbFace(), adjointRotatingWallVelocityFvPatchVectorField::dxdbMult(), solidAbsorption::e(), faPatch::edgeFaceCentres(), faPatch::edgeNormals(), cloudAbsorptionEmission::eDisp(), SpalartAllmaras< BasicTurbulenceModel >::epsilon(), age::execute(), energyTransport::execute(), boundedBackwardFaDdtScheme::facDdt(), boundBox::faceCentres(), mappedPatchBase::facePoints(), parseDriver::field_cellCentre(), parseDriver::field_rand(), NURBS3DSurface::findClosestSurfacePoint(), adjointLaminar::FISensitivityTerm(), fft::forwardTransform(), interfaceTrackingFvMesh::freeSurfacePressureJump(), interfaceTrackingFvMesh::freeSurfaceSnGradU(), interfaceTrackingFvMesh::freeSurfaceSnGradUn(), noiseFFT::frequencies(), kOmegaSSTBase< eddyViscosity< RASModel< BasicTurbulenceModel > > >::gamma(), phaseSystem::generatePhi(), Foam::getField(), cancelATC::getFISensitivityTerm(), blockMesh::globalPosition(), adjointEikonalSolver::gradEikonal(), lduMatrix::H1(), faMesh::haloFaceCentres(), faMesh::haloFaceNormals(), multiphaseMangrovesSource::inertiaCoeff(), rotorDiskSource::inflowVelocity(), cyclicACMIGAMGInterface::internalFieldTransfer(), AssemblyFvPatch< CyclicType >::internalFieldTransfer(), cyclicFaPatch::internalFieldTransfer(), Foam::inv(), coordinateSystem::invTransformPointImpl(), SpalartAllmaras< BasicTurbulenceModel >::k(), interfaceHeatResistance< Thermo, OtherThermo >::Kexp(), kL< BasicTurbulenceModel >::kSource(), interfaceHeatResistance< Thermo, OtherThermo >::KSu(), upwind< Type >::limiter(), cylindrical::localToGlobal(), meshRefinement::makeDisplacementField(), noiseModel::meanPf(), steadyStateDdtScheme< Type >::meshPhi(), incompressibleTwoPhaseMixture::mu(), incompressibleTwoPhaseMixture::muf(), laminar::mut(), phaseSystem::nearInterface(), faPatch::ngbPolyPatchFaceNormals(), faPatch::ngbPolyPatchPointNormals(), adjointTurbulenceModel::nuEff(), incompressibleTwoPhaseMixture::nuf(), Stokes< BasicTurbulenceModel >::nut(), generalizedNewtonian< BasicMomentumTransportModel >::nut(), adjointRASModel::nutJacobianTMVar1(), adjointRASModel::nutJacobianTMVar2(), SpalartAllmaras::nutJacobianVar1(), RASModelVariables::nutJacobianVar1(), RASModelVariables::nutJacobianVar2(), noiseModel::octaves(), SpalartAllmaras< BasicTurbulenceModel >::omega(), NURBS3DVolume::patchDxDb(), NURBS3DVolume::patchDxDbFace(), noiseFFT::Pf(), noiseModel::Pf(), semiPermeableBaffleMassFractionFvPatchScalarField::phiY(), boundBox::points(), treeBoundBox::points(), searchablePlate::points(), searchableCylinder::points(), searchableSurfaceCollection::points(), searchableCone::points(), lumpedPointMovement::pointsDisplacement(), lumpedPointMovement::pointsPosition(), projectCurveEdge::position(), projectEdge::position(), blockEdge::position(), filmTurbulenceModel::primaryRegionFriction(), noiseModel::PSDf(), dummy::R(), lumpedPointMovement::readDict(), reader::readField(), fft::realTransform1D(), fft::reverseTransform(), filmTurbulenceModel::rho(), forces::rho(), twoPhaseMixtureEThermo::rhoEoS(), twoPhaseMixtureThermo::rhoEoS(), multiphaseMixtureThermo::rhoEoS(), coordinateSystem::rotationsImpl(), noRadiation::Rp(), opaqueSolid::Rp(), viewFactor::Rp(), solarLoad::Rp(), noRadiation::Ru(), opaqueSolid::Ru(), Foam::safeLog10(), mappedPatchBase::samplePoints(), noFilm::Sh(), ThermoCloud< CloudType >::Sh(), kinematicSingleLayer::Sh(), noRadiation::Shs(), constantSurfaceTensionCoefficient::sigma(), constant::sigma(), temperatureDependent::sigma(), electrostaticDepositionFvPatchScalarField::sigma(), wedgeFvPatchField< Type >::snGrad(), timeVaryingMassSorptionFvPatchScalarField::source(), noFilm::Srho(), kinematicSingleLayer::Srho(), Foam::stabilise(), stabilityBlendingFactor::stabilityBlendingFactor(), phaseSystem::surfaceTensionForce(), interfaceTrackingFvMesh::surfaceTensionGrad(), targetCoeffTrim::thetag(), boundaryAdjointContribution::TMVariable1(), boundaryAdjointContribution::TMVariable1Diffusion(), boundaryAdjointContribution::TMVariable2(), boundaryAdjointContribution::TMVariable2Diffusion(), cyclicFaPatch::transfer(), Foam::transformFieldMask< tensor >(), coordinateSystem::transformPointImpl(), phaseSystem::U(), noiseModel::uniformFrequencies(), triSurfaceTools::vertexNormals(), triSurfaceTools::vertexTriads(), blockMesh::vertices(), waveModel::waterLevel(), surfaceFieldValue::weightingFactor(), electricPotential::write(), rotorDiskSource::writeField(), TableBase< Type >::x(), general::x(), general::y(), nutkWallFunctionFvPatchScalarField::yPlus(), and alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField::yPlusTherm().

◆ NewFrom() [1/2]

static tmp<T> NewFrom ( Args &&...  args)
inlinestatic

◆ typeName()

Foam::word typeName ( )
inlinestatic

Definition at line 62 of file tmpI.H.

◆ good()

bool good ( ) const
inlinenoexcept

Definition at line 165 of file tmp.H.

◆ is_const()

bool is_const ( ) const
inlinenoexcept

Definition at line 168 of file tmp.H.

◆ is_pointer()

bool is_pointer ( ) const
inlinenoexcept

Definition at line 171 of file tmp.H.

Referenced by regIOobject::store().

Here is the caller graph for this function:

◆ movable()

bool movable ( ) const
inlinenoexcept

Definition at line 199 of file tmpI.H.

◆ get() [1/2]

T* get ( )
inlinenoexcept

Definition at line 180 of file tmp.H.

Referenced by regIOobject::store().

Here is the caller graph for this function:

◆ get() [2/2]

const T* get ( ) const
inlinenoexcept

Definition at line 183 of file tmp.H.

◆ cref() [1/4]

const T & cref ( ) const
inline

◆ ref() [1/3]

T & ref ( ) const
inline

Definition at line 220 of file tmpI.H.

Referenced by faMatrix< Type >::A(), fvMatrix< Type >::A(), MRFZoneList::absolute(), multiBandZoneAbsorptionEmission::aCont(), greyMeanAbsorptionEmission::aCont(), wideBandAbsorptionEmission::aCont(), phaseChange::addToDriftRate(), cloudAbsorptionEmission::aDisp(), adjointSensitivity::adjointMeshMovementSource(), pairGAMGAgglomeration::agglomerate(), adjointSolverManager::aggregateSensitivities(), liquidFilmBase::alpha(), KinematicCloud< Cloud< basicKinematicCollidingParcel > >::alpha(), phaseSystem::alphaEff(), phaseSystem::alphahe(), MassTransferPhaseSystem< BasePhaseSystem >::alphaTransfer(), ThermoCloud< CloudType >::ap(), polyPatch::areaFraction(), Foam::atan2(), Foam::fac::average(), Foam::fvc::average(), averageNeighbourFvGeometryScheme::averageCentres(), averageNeighbourFvGeometryScheme::averageNeighbourCentres(), snappySnapDriver::avgCellCentres(), subtract::calcFieldType(), add::calcFieldType(), faceLimitedGrad< Type >::calcGrad(), faceMDLimitedGrad< Type >::calcGrad(), cellMDLimitedGrad< Type >::calcGrad(), curvatureSeparation::calcInvR1(), nutkWallFunctionFvPatchScalarField::calcNut(), nutUWallFunctionFvPatchScalarField::calcNut(), nutkRoughWallFunctionFvPatchScalarField::calcNut(), nutUSpaldingWallFunctionFvPatchScalarField::calcNut(), phaseSystem::calcPhi(), StandardChemistryModel< ReactionThermo, ThermoType >::calculateRR(), nutUTabulatedWallFunctionFvPatchScalarField::calcUPlus(), nutkFilmWallFunctionFvPatchScalarField::calcUTau(), nutUBlendedWallFunctionFvPatchScalarField::calcUTau(), nutUSpaldingWallFunctionFvPatchScalarField::calcUTau(), nutUWallFunctionFvPatchScalarField::calcYPlus(), primitiveMeshTools::cellDeterminant(), Zuber::CHF(), Tatsumoto::CHFSubCool(), HuaXu::CHFSubCool(), Foam::cmptMag(), optimisationType::computeDirection(), adjointSensitivity::computeGradDxDbMultiplier(), NURBS3DVolume::computeNewBoundaryPoints(), NURBS3DVolume::computeNewPoints(), NURBS3DVolume::computeParametricCoordinates(), Foam::constrainHbyA(), adjointSolverManager::constraintValues(), shapeSensitivitiesBase::constructVolSensitivtyField(), forceList::correct(), thermocapillaryForce::correct(), contactAngleForce::correct(), DeardorffDiffStress< BasicTurbulenceModel >::correct(), Maxwell< BasicTurbulenceModel >::correct(), ShihQuadraticKE::correct(), LamBremhorstKE::correct(), LienLeschziner::correct(), kOmega< BasicTurbulenceModel >::correct(), LienCubicKE::correct(), SSG< BasicTurbulenceModel >::correct(), realizableKE< BasicTurbulenceModel >::correct(), kEpsilon< EddyDiffusivity< compressible::turbulenceModel > >::correct(), LaunderSharmaKE< BasicTurbulenceModel >::correct(), RNGkEpsilon< BasicTurbulenceModel >::correct(), LRR< BasicTurbulenceModel >::correct(), qZeta::correct(), kEpsilonLopesdaCosta< BasicTurbulenceModel >::correct(), SpalartAllmarasDES< BasicTurbulenceModel >::correct(), SpalartAllmaras< BasicTurbulenceModel >::correct(), mixtureKEpsilon< BasicTurbulenceModel >::correct(), kEpsilonPhitF< BasicTurbulenceModel >::correct(), kkLOmega::correct(), adjointSpalartAllmaras::correct(), kOmegaSSTBase< eddyViscosity< RASModel< BasicTurbulenceModel > > >::correct(), kL< BasicTurbulenceModel >::correct(), correctedLnGrad< Type >::correction(), fourthLnGrad< Type >::correction(), cubic< Type >::correction(), CentredFitSnGradScheme< Type, Polynomial, Stencil >::correction(), pointLinear< Type >::correction(), linearUpwind< Type >::correction(), correctedSnGrad< Type >::correction(), faceCorrectedSnGrad< Type >::correction(), deferredCorrection< Type >::correction(), relaxedSnGrad< Type >::correction(), linearUpwindV< Type >::correction(), outletStabilised< Type >::correction(), MassTransferPhaseSystem< BasePhaseSystem >::correctMassSources(), kOmegaSSTLM< BasicTurbulenceModel >::correctReThetatGammaInt(), constantFilmThermo::Cp(), phaseSystem::Cp(), heThermo< BasicSolidThermo, MixtureType >::CpByCpv(), phaseSystem::CpByCpv(), heThermo< BasicSolidThermo, MixtureType >::Cpv(), phaseSystem::Cpv(), cellCellStencil::createField(), Foam::fvc::curl(), solidBodyMotionSolver::curPoints(), multiSolidBodyMotionSolver::curPoints(), volumetricBSplinesMotionSolver::curPoints(), velocityComponentLaplacianFvMotionSolver::curPoints(), velocityLaplacianFvMotionSolver::curPoints(), displacementComponentLaplacianFvMotionSolver::curPoints(), displacementSBRStressFvMotionSolver::curPoints(), sixDoFRigidBodyMotionSolver::curPoints(), displacementInterpolationMotionSolver::curPoints(), solidBodyDisplacementLaplacianFvMotionSolver::curPoints(), laplacianMotionSolver::curPoints(), displacementLaplacianFvMotionSolver::curPoints(), rigidBodyMeshMotion::curPoints(), motionSmootherAlgo::curPoints(), phaseSystem::Cv(), multiphaseSystem::Cvm(), faMatrix< Type >::D(), fvMatrix< Type >::D(), fvMatrix< Type >::DD(), MomentumTransferPhaseSystem< BasePhaseSystem >::ddtCorrByAs(), fvFieldDecomposer::decomposeField(), cyclicFvPatch::delta(), fvMesh::delta(), basicFvGeometryScheme::deltaCoeffs(), blackBodyEmission::deltaLambdaT(), nonlinearEddyViscosity< incompressible::RASModel >::devRhoReff(), adjointSpalartAllmaras::diffusionCoeffVar1(), adjointSpalartAllmaras::distanceSensitivities(), Foam::fam::div(), Foam::fac::div(), NURBS3DVolume::dndbBasedSensitivities(), adjointSpalartAllmaras::dr_dDelta(), adjointSpalartAllmaras::dr_dNuTilda(), adjointSpalartAllmaras::dr_dStilda(), multiphaseSystem::dragCoeff(), SpalartAllmarasDES< BasicTurbulenceModel >::dTilda(), shapeSensitivities::dvdbMult(), blackBodyEmission::EbDeltaLambdaT(), multiBandZoneAbsorptionEmission::eCont(), greyMeanAbsorptionEmission::ECont(), wideBandAbsorptionEmission::ECont(), Foam::fac::edgeIntegrate(), faMesh::edgeLengthCorrection(), Foam::fac::edgeSum(), cloudAbsorptionEmission::EDisp(), ThermoCloud< CloudType >::Ep(), edgeInterpolationScheme< Type >::euclidianInterpolate(), scalarTransport::execute(), kOmegaSSTBase< eddyViscosity< RASModel< BasicTurbulenceModel > > >::F23(), EulerFaD2dt2Scheme< Type >::facD2dt2(), EulerFaDdtScheme< Type >::facDdt(), backwardFaDdtScheme< Type >::facDdt(), boundedBackwardFaDdtScheme::facDdt(), EulerFaDdtScheme< Type >::facDdt0(), backwardFaDdtScheme< Type >::facDdt0(), boundedBackwardFaDdtScheme::facDdt0(), gaussConvectionScheme< Type >::facDiv(), polyPatch::faceCellCentres(), primitiveMeshTools::faceConcavity(), primitiveMeshTools::faceFlatness(), lduMatrix::faceH(), PatchToPatchInterpolation< FromPatch, ToPatch >::faceInterpolate(), cellQuality::faceNonOrthogonality(), polyMeshTools::faceOrthogonality(), primitiveMeshTools::faceOrthogonality(), polyMeshTools::faceSkewness(), cellQuality::faceSkewness(), primitiveMeshTools::faceSkewness(), PrimitivePatchInterpolation< Patch >::faceToPointInterpolate(), polyMeshTools::faceWeights(), gaussLaplacianScheme< Type >::facLaplacian(), EulerFaD2dt2Scheme< Type >::famD2dt2(), EulerFaDdtScheme< Type >::famDdt(), backwardFaDdtScheme< Type >::famDdt(), boundedBackwardFaDdtScheme::famDdt(), gaussConvectionScheme< Type >::famDiv(), gaussLaplacianScheme< Type >::famLaplacian(), Foam::edgeMeshTools::featureProximity(), volPointInterpolation::flatBoundaryField(), kOmegaSSTLM< BasicTurbulenceModel >::Flength(), faMatrix< Type >::flux(), fvMatrix< Type >::flux(), correctedSnGrad< Type >::fullGradCorrection(), faceCorrectedSnGrad< Type >::fullGradCorrection(), EulerDdtScheme< Type >::fvcDdt(), CoEulerDdtScheme< Type >::fvcDdt(), backwardDdtScheme< Type >::fvcDdt(), SLTSDdtScheme< Type >::fvcDdt(), CrankNicolsonDdtScheme< Type >::fvcDdt(), ddtScheme< Type >::fvcDdtPhiCoeff(), ddtScheme< Type >::fvcDdtPhiCoeffExperimental(), steadyStateDdtScheme< Type >::fvcDdtPhiCorr(), steadyStateDdtScheme< Type >::fvcDdtUfCorr(), gaussConvectionScheme< Type >::fvcDiv(), gaussLaplacianScheme< Type, GType >::fvcLaplacian(), relaxedNonOrthoGaussLaplacianScheme< Type, GType >::fvcLaplacian(), EulerD2dt2Scheme< Type >::fvmD2dt2(), EulerDdtScheme< Type >::fvmDdt(), CoEulerDdtScheme< Type >::fvmDdt(), backwardDdtScheme< Type >::fvmDdt(), SLTSDdtScheme< Type >::fvmDdt(), localEulerDdtScheme< Type >::fvmDdt(), gaussConvectionScheme< Type >::fvmDiv(), gaussLaplacianScheme< Type, GType >::fvmLaplacian(), relaxedNonOrthoGaussLaplacianScheme< Type, GType >::fvmLaplacian(), gaussLaplacianScheme< Type, GType >::fvmLaplacianUncorrected(), relaxedNonOrthoGaussLaplacianScheme< Type, GType >::fvmLaplacianUncorrected(), heThermo< BasicSolidThermo, MixtureType >::gamma(), phaseSystem::gamma(), pyrolysisChemistryModel< CompType, SolidThermo, GasThermo >::gasHs(), fvMeshDistribute::generateTestField(), NURBS3DVolume::getDxCellsDb(), NURBS3DVolume::getDxDb(), ATCstandard::getFISensitivityTerm(), ATCUaGradU::getFISensitivityTerm(), adjointEikonalSolver::getFISensitivityTerm(), cylindrical::globalToLocal(), kinematicSingleLayer::gNormClipped(), Foam::fac::grad(), lduMatrix::H(), faMatrix< Type >::H(), fvMatrix< Type >::H(), fvMatrix< Type >::H1(), heThermo< BasicSolidThermo, MixtureType >::hc(), phaseSystem::hc(), heThermo< BasicSolidThermo, MixtureType >::he(), MassTransferPhaseSystem< BasePhaseSystem >::heatTransfer(), AnisothermalPhaseModel< BasePhaseModel >::heEqn(), heheuPsiThermo< BasicPsiThermo, MixtureType >::heu(), coalCloudList::hsTrans(), BreenWestwater::htcFilmBoil(), Bromley::htcFilmBoil(), InterfaceCompositionPhaseChangePhaseSystem< BasePhaseSystem >::iDmdt(), cyclicAMIGAMGInterface::internalFieldTransfer(), cyclicGAMGInterface::internalFieldTransfer(), Foam::interpolate(), pointToPointPlanarInterpolation::interpolate(), pointVolInterpolation::interpolate(), localMax< Type >::interpolate(), localMin< Type >::interpolate(), edgeInterpolationScheme< Type >::interpolate(), surfaceInterpolationScheme< scalar >::interpolate(), singleCellFvMesh::interpolate(), Foam::inv(), ReynoldsStress< RASModel< BasicTurbulenceModel > >::k(), SpalartAllmarasDES< BasicTurbulenceModel >::k(), phaseSystem::K(), heSolidThermo< BasicSolidThermo, MixtureType >::Kappa(), liquidFilmThermo::kappa(), constantFilmThermo::kappa(), phaseSystem::kappa(), kineticGasEvaporation< Thermo, OtherThermo >::Kexp(), interfaceOxideRate< Thermo, OtherThermo >::Kexp(), boundaryAdjointContributionIncompressible::laminarDiffusivity(), Foam::levelSetFraction(), PhiScheme< Type, PhiLimiter >::limiter(), LimitedScheme< Type, Limiter, LimitFunc >::limiter(), steadyOptimisation::lineSearchUpdate(), lnGradScheme< Type >::lnGrad(), Foam::fvc::magSqrGradGrad(), adjointSimple::mainIter(), cyclicAMIFvPatchField< scalar >::manipulateMatrix(), cyclicACMIFvPatchField< Type >::manipulateMatrix(), mappedPatchFieldBase< scalar >::mappedInternalField(), mappedPatchFieldBase< scalar >::mappedWeightField(), meshToMesh::mapSrcToTgt(), meshToMesh::mapTgtToSrc(), momentOfInertia::meshInertia(), CoEulerDdtScheme< Type >::meshPhi(), SLTSDdtScheme< Type >::meshPhi(), localEulerDdtScheme< Type >::meshPhi(), Jeschar::MHF(), boundaryAdjointContributionIncompressible::momentumDiffusion(), regionModel1D::moveMesh(), fvMesh::movePoints(), primitiveMesh::movePoints(), liquidFilmThermo::mu(), constantFilmThermo::mu(), phaseSystem::mu(), heheuPsiThermo< BasicPsiThermo, MixtureType >::mub(), heheuPsiThermo< BasicPsiThermo, MixtureType >::muu(), Foam::fac::ndiv(), multiphaseSystem::nearInterface(), Foam::fac::ngrad(), basicFvGeometryScheme::nonOrthCorrectionVectors(), basicFvGeometryScheme::nonOrthDeltaCoeffs(), cellQuality::nonOrthogonality(), dynamicOversetFvMesh::normalisation(), Schaeffer::nu(), JohnsonJacksonSchaeffer::nu(), multiphaseSystem::nu(), phaseSystem::nu(), consumptionSpeed::omega0Sigma(), anisotropicFilter::operator()(), optionList::operator()(), RaviPetersen::operator()(), cyclicFaPatchField< Type >::patchNeighbourField(), cyclicFvPatchField< vector >::patchNeighbourField(), cyclicAMIFvPatchField< scalar >::patchNeighbourField(), cyclicACMIFvPatchField< Type >::patchNeighbourField(), liquidFilmBase::pg(), PatchToPatchInterpolation< FromPatch, ToPatch >::pointInterpolate(), PatchTools::pointNormals(), PrimitivePatchInterpolation< Patch >::pointToFaceInterpolate(), Foam::pow(), phasePressureModel::pPrime(), kineticTheoryModel::pPrime(), phasePressureModel::pPrimef(), boundaryAdjointContributionIncompressible::pressureSource(), filmTurbulenceModel::primaryRegionFriction(), SpalartAllmarasDES< BasicTurbulenceModel >::psi(), heheuPsiThermo< BasicPsiThermo, MixtureType >::psib(), heheuPsiThermo< BasicPsiThermo, MixtureType >::psiu(), laminar< ReactionThermo >::Qdot(), diffusionMulticomponent< ReactionThermo, ThermoType >::Qdot(), EDC< ReactionThermo >::Qdot(), solidChemistryModel< CompType, SolidThermo >::Qdot(), StandardChemistryModel< ReactionThermo, ThermoType >::Qdot(), Kutadeladze::qNucleate(), greyDiffusiveViewFactorFixedValueFvPatchScalarField::qro(), nonlinearEddyViscosity< incompressible::RASModel >::R(), laminar< ReactionThermo >::R(), diffusionMulticomponent< ReactionThermo, ThermoType >::R(), reader::readField(), Foam::fvc::reconstruct(), Foam::fvc::reconstructMag(), MRFZoneList::relative(), faMatrix< Type >::residual(), fvMatrix< Type >::residual(), LduMatrix< Type, DType, LUType >::residual(), lduMatrix::residual(), kOmegaSSTLM< BasicTurbulenceModel >::ReThetac(), kOmegaSSTLM< BasicTurbulenceModel >::ReThetat0(), constantFilmThermo::rho(), phaseSystem::rho(), KinematicCloud< Cloud< basicKinematicCollidingParcel > >::rhoEff(), coalCloudList::rhoTrans(), fvDOM::Rp(), solidChemistryModel< CompType, SolidThermo >::RRsHs(), eddyDissipationDiffusionModel< ReactionThermo, ThermoType >::rtDiff(), fvDOM::Ru(), patchProbes::sample(), probes::sample(), coalCloudList::Sh(), ThermoCloud< CloudType >::Sh(), thermoSingleLayer::Sh(), primaryRadiation::Shs(), standardRadiation::Shs(), constantRadiation::Shs(), liquidFilmThermo::sigma(), constantFilmThermo::sigma(), electrostaticDepositionFvPatchScalarField::sigma(), cloudScatter::sigmaEff(), ThermoCloud< CloudType >::sigmap(), skewCorrectedEdgeInterpolation< Type >::skewCorrection(), skewCorrected< Type >::skewCorrection(), cellQuality::skewness(), snGradScheme< Type >::snGrad(), twoPhaseSystem::solve(), surfaceAlignedSBRStressFvMotionSolver::solve(), thermalBaffle::solveEnergy(), sensitivityBezierFI::solveMeshMovementEqn(), fvMatrix< Type >::solveSegregated(), optionList::source(), Foam::fam::Sp(), noiseModel::SPL(), Foam::sqr(), coalCloudList::Srho(), ReactingCloud< CloudType >::Srho(), thermoSingleLayer::Srho(), Foam::stabilise(), regionFunctionObject::store(), regionFunctionObject::storeInDb(), Foam::fam::Su(), coalCloudList::SU(), KinematicCloud< Cloud< basicKinematicCollidingParcel > >::SU(), Foam::fvc::surfaceIntegrate(), surfaceNormalFixedValueFvPatchVectorField::surfaceNormalFixedValueFvPatchVectorField(), Foam::fvc::surfaceSum(), multiphaseSystem::surfaceTension(), Foam::fam::SuSp(), multiphaseSystem::Svm(), coalCloudList::SYi(), ReactingCloud< CloudType >::SYi(), thermoSingleLayer::T(), boundaryAdjointContributionIncompressible::tangentVelocitySource(), heheuPsiThermo< BasicPsiThermo, MixtureType >::Tb(), StandardChemistryModel< ReactionThermo, ThermoType >::tc(), heThermo< BasicSolidThermo, MixtureType >::THE(), temperatureDependentContactAngleForce::theta(), distributionContactAngleForce::theta(), perturbedTemperatureDependentContactAngleForce::theta(), KinematicCloud< Cloud< basicKinematicCollidingParcel > >::theta(), boundaryAdjointContributionIncompressible::TMVariable1(), boundaryAdjointContributionIncompressible::TMVariable2(), Foam::transform(), sixDoFRigidBodyMotion::transform(), rigidBodyMotion::transformPoints(), Foam::transformPoints(), polynomial::Tsat(), function1::Tsat(), SRFModel::Uabs(), liquidFilmBase::Up(), optimisationType::update(), inverseDistance::update(), adjointWallVelocityLowReFvPatchVectorField::updateCoeffs(), adjointFarFieldVelocityFvPatchVectorField::updateCoeffs(), adjointOutletPressureFvPatchScalarField::updateCoeffs(), adjointFarFieldPressureFvPatchScalarField::updateCoeffs(), surfaceNormalFixedValueFvPatchVectorField::updateCoeffs(), uniformNormalFixedValueFvPatchVectorField::updateCoeffs(), lumpedMassWallTemperatureFvPatchScalarField::updateCoeffs(), turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::updateCoeffs(), timeVaryingMassSorptionFvPatchScalarField::updateCoeffs(), electrostaticDepositionFvPatchScalarField::updateCoeffs(), laminar::Us(), liquidFilmBase::Us(), coalCloudList::UTrans(), liquidFilmBase::Uw(), KinematicCloud< Cloud< basicKinematicCollidingParcel > >::vDotSweep(), boundaryAdjointContributionIncompressible::velocitySource(), polyMeshTools::volRatio(), MassTransferPhaseSystem< BasePhaseSystem >::volTransfer(), heThermo< BasicSolidThermo, MixtureType >::W(), boundaryAdjointContributionIncompressible::wallDistance(), extendedUpwindCellToFaceStencil::weightedSum(), extendedFaceToCellStencil::weightedSum(), extendedCellToFaceStencil::weightedSum(), basicFvGeometryScheme::weights(), midPoint< Type >::weights(), reverseLinear< Type >::weights(), clippedLinear< Type >::weights(), outletStabilised< Type >::weights(), faNVDscheme< Type, NVDweight >::weights(), limitedSurfaceInterpolationScheme< Type >::weights(), triSurfaceTools::writeCurvature(), Foam::edgeMeshTools::writeFeatureProximity(), Foam::ensightOutput::writeVolField(), nutUWallFunctionFvPatchScalarField::yPlus(), MRFZoneList::zeroFilter(), and wallLubricationModel::zeroGradWalls().

◆ constCast()

T & constCast ( ) const
inline

Definition at line 241 of file tmpI.H.

Referenced by LESfilter::correctBoundaryConditions(), waveVelocityFvPatchVectorField::updateCoeffs(), and waveAlphaFvPatchScalarField::updateCoeffs().

Here is the caller graph for this function:

◆ ptr()

T * ptr ( ) const
inline

◆ clear()

void clear ( ) const
inlinenoexcept

Definition at line 280 of file tmpI.H.

Referenced by MRFZoneList::absolute(), boundBox::add(), lduMatrix::Amul(), kEqn< BasicTurbulenceModel >::correct(), LamBremhorstKE::correct(), LienLeschziner::correct(), kOmega< BasicTurbulenceModel >::correct(), dynamicKEqn< BasicTurbulenceModel >::correct(), kEpsilon< EddyDiffusivity< compressible::turbulenceModel > >::correct(), LaunderSharmaKE< BasicTurbulenceModel >::correct(), RNGkEpsilon< BasicTurbulenceModel >::correct(), kEpsilonLopesdaCosta< BasicTurbulenceModel >::correct(), mixtureKEpsilon< BasicTurbulenceModel >::correct(), kEpsilonPhitF< BasicTurbulenceModel >::correct(), kOmegaSSTBase< eddyViscosity< RASModel< BasicTurbulenceModel > > >::correct(), kL< BasicTurbulenceModel >::correct(), kOmegaSSTLM< BasicTurbulenceModel >::correctReThetatGammaInt(), triSurfaceTools::curvatures(), Foam::fvc::DDt(), Foam::fvm::div(), Foam::fam::div(), Foam::fvc::div(), Foam::fac::div(), edgeInterpolationScheme< Type >::euclidianInterpolate(), Foam::fvc::flux(), fft::forwardTransform(), updateMethod::globalSum(), fvMeshSubsetProxy::interpolate(), edgeInterpolationScheme< Type >::interpolate(), surfaceInterpolationScheme< scalar >::interpolate(), Foam::inv(), Foam::fac::laplacian(), Foam::fam::laplacian(), adjointSimple::mainIter(), Foam::fam::ndiv(), Foam::fac::ndiv(), anisotropicFilter::operator()(), noiseFFT::Pf(), realizableKE< BasicTurbulenceModel >::rCmu(), fft::realTransform1D(), Foam::fvc::reconstructMag(), MRFZoneList::relative(), fft::reverseTransform(), snGradScheme< Type >::snGrad(), Foam::fam::Sp(), Foam::stabilise(), Foam::fam::SuSp(), lduMatrix::Tmul(), Foam::transform(), PatchFunction1< Type >::transform(), Foam::transformFieldMask< sphericalTensor >(), Foam::transformFieldMask< symmTensor >(), Foam::transformFieldMask< tensor >(), Foam::transformPoints(), Foam::fvc::volumeIntegrate(), Foam::writeAreaField(), Foam::writeDimField(), Foam::writePointField(), and Foam::writeVolField().

◆ reset() [1/2]

void reset ( tmp< T > &&  other)
inlinenoexcept

◆ reset() [2/2]

void reset ( T p = nullptr)
inlinenoexcept

◆ cref() [2/4]

void cref ( const tmp< T > &  other)
inlinenoexcept

◆ cref() [3/4]

void cref ( const T obj)
inlinenoexcept

◆ cref() [4/4]

void cref ( const T p)
inlinenoexcept

◆ ref() [2/3]

void ref ( T obj)
inlinenoexcept

◆ ref() [3/3]

void ref ( T p)
inlinenoexcept

◆ swap()

void swap ( tmp< T > &  other)
inlinenoexcept

Definition at line 374 of file tmpI.H.

◆ operator->() [1/2]

const T * operator-> ( ) const
inline

Definition at line 391 of file tmpI.H.

◆ operator->() [2/2]

T * operator-> ( )
inline

Definition at line 405 of file tmpI.H.

◆ operator()()

const T& operator() ( ) const
inline

Definition at line 256 of file tmp.H.

◆ operator bool()

operator bool ( ) const
inlineexplicitnoexcept

Definition at line 262 of file tmp.H.

◆ operator const T &()

operator const T & ( ) const
inline

Definition at line 265 of file tmp.H.

◆ operator=() [1/4]

void operator= ( const tmp< T > &  other)
inline

Definition at line 426 of file tmpI.H.

◆ operator=() [2/4]

void operator= ( tmp< T > &&  other)
inlinenoexcept

◆ operator=() [3/4]

void operator= ( T p)
inline

Definition at line 477 of file tmpI.H.

◆ operator=() [4/4]

void operator= ( std::nullptr_t  )
inlinenoexcept

◆ valid()

bool valid ( ) const
inlinenoexcept

◆ isTmp()

bool isTmp ( ) const
inlinenoexcept

◆ empty()

bool empty ( ) const
inlinenoexcept

Definition at line 297 of file tmp.H.

◆ New() [2/2]

Foam::tmp<T> New ( Args &&...  args)
inline

Definition at line 47 of file tmpI.H.

◆ NewFrom() [2/2]

Foam::tmp<T> NewFrom ( Args &&...  args)
inline

Definition at line 55 of file tmpI.H.


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