tmp< T > Class Template Reference

A class for managing temporary objects. More...

Inheritance diagram for tmp< T >:

Public Types

typedef T Type
 The type. More...
 
typedef Foam::refCount refCount
 The reference counting class. More...
 

Public Member Functions

 tmp (T *=0, bool nonReusable=false)
 Store object pointer of a non-reusable or reusable temporary object. More...
 
 tmp (const T &)
 Store object const reference. More...
 
 tmp (const tmp< T > &)
 Construct copy and increment reference count. More...
 
 tmp (tmp< T > &&)
 Construct copy moving content, does not increment reference count. More...
 
 tmp (const tmp< T > &&)
 Construct copy moving content, does not increment reference count. More...
 
 tmp (const tmp< T > &, bool allowTransfer)
 Construct copy transferring content of temporary if required. More...
 
 ~tmp ()
 Destructor. Deletes temporary object when the reference count is 0. More...
 
bool isTmp () const
 Return true if this is really a temporary object. More...
 
bool empty () const
 Return true if this temporary object empty,. More...
 
bool valid () const
 Is this temporary object valid,. More...
 
word typeName () const
 Return the type name of the tmp. More...
 
Tref () const
 Return non-const reference or generate a fatal error. More...
 
Tptr () const
 Return tmp pointer for reuse. More...
 
void clear () const
 If object pointer points to valid object: More...
 
const Toperator() () const
 Const dereference operator. More...
 
 operator const T & () const
 Const cast to the underlying type reference. More...
 
Toperator-> ()
 Return object pointer. More...
 
const Toperator-> () const
 Return const object pointer. More...
 
void operator= (T *)
 Assignment to pointer changing this tmp to a temporary T. More...
 
void operator= (const tmp< T > &)
 Assignment transferring the temporary T to this tmp. More...
 
void operator= (tmp< T > &&)
 Move assignment transferring the temporary T to this tmp. More...
 
void operator= (const tmp< T > &&)
 Move assignment transferring the temporary T to this tmp. More...
 

Detailed Description

template<class T>
class Foam::tmp< T >

A class for managing temporary objects.

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

Definition at line 54 of file tmp.H.

Member Typedef Documentation

◆ Type

typedef T Type

The type.

Definition at line 90 of file tmp.H.

◆ refCount

The reference counting class.

Definition at line 93 of file tmp.H.

Constructor & Destructor Documentation

◆ tmp() [1/6]

tmp ( T tPtr = 0,
bool  nonReusable = false 
)
inlineexplicit

Store object pointer of a non-reusable or reusable temporary object.

Definition at line 59 of file tmpI.H.

References Foam::abort(), Foam::FatalError, FatalErrorInFunction, and tmp< T >::typeName().

Here is the call graph for this function:

◆ tmp() [2/6]

tmp ( const T tRef)
inline

Store object const reference.

Definition at line 75 of file tmpI.H.

◆ tmp() [3/6]

tmp ( const tmp< T > &  t)
inline

Construct copy and increment reference count.

Definition at line 83 of file tmpI.H.

References Foam::abort(), Foam::FatalError, FatalErrorInFunction, and tmp< T >::typeName().

Here is the call graph for this function:

◆ tmp() [4/6]

tmp ( tmp< T > &&  t)
inline

Construct copy moving content, does not increment reference count.

Definition at line 105 of file tmpI.H.

◆ tmp() [5/6]

tmp ( const tmp< T > &&  t)
inline

Construct copy moving content, does not increment reference count.

Definition at line 118 of file tmpI.H.

◆ tmp() [6/6]

tmp ( const tmp< T > &  t,
bool  allowTransfer 
)
inline

Construct copy transferring content of temporary if required.

Definition at line 131 of file tmpI.H.

◆ ~tmp()

~tmp
inline

Destructor. Deletes temporary object when the reference count is 0.

Definition at line 160 of file tmpI.H.

References clear().

Here is the call graph for this function:

Member Function Documentation

◆ isTmp()

bool isTmp
inline

Return true if this is really a temporary object.

Definition at line 169 of file tmpI.H.

Referenced by coupledTemperatureFvPatchScalarField::add(), DispersionRASModel< CloudType >::cacheFields(), Foam::constrainPhiHbyA(), and CarrierField< Type >::Function< Type >::operator()().

Here is the caller graph for this function:

◆ empty()

bool empty
inline

Return true if this temporary object empty,.

ie, a temporary without allocation

Definition at line 176 of file tmpI.H.

◆ valid()

◆ typeName()

Foam::word typeName
inline

Return the type name of the tmp.

constructed from the type name of T

Definition at line 190 of file tmpI.H.

References Foam::name(), and Foam::T().

Referenced by tmp< T >::tmp().

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

◆ ref()

T & ref
inline

Return non-const reference or generate a fatal error.

if the object is const.

Definition at line 197 of file tmpI.H.

References Foam::abort(), Foam::FatalError, and FatalErrorInFunction.

Referenced by fvMatrix< Type >::A(), MRFZoneList::absolute(), accumulationScheme< Type >::accumulate(), greyMean::aCont(), wideBand::aCont(), coupledTemperatureFvPatchScalarField::add(), interRegionHeatTransfer::addSup(), cloud::aDisp(), pairGAMGAgglomeration::agglomerate(), GAMGInterface::agglomerateCoeffs(), LagrangianEqn< Type >::allDiagonalSp(), LagrangianEqn< Type >::allDiagonalSu(), LagrangianEqn< Type >::allSp(), LagrangianEqn< Type >::allSu(), MomentumCloud< CloudType >::alpha(), parcelCloudList::alpha(), blendingMethod::alpha(), compressibleMultiphaseVoFMixture::alphaEff(), waveAlphaFvPatchScalarField::alphan(), twoPhaseSolver::alphaPredictor(), compressibleVoF::alphaSuSp(), incompressibleDriftFlux::alphaSuSp(), incompressibleVoF::alphaSuSp(), alphatJayatillekeWallFunctionFvPatchScalarField::alphat(), ThermoCloud< CloudType >::ap(), parcelCloudList::ap(), patchCutLayerAverage::applyWeights(), cutLayerAverage::applyWeights(), Foam::atan2(), velocityGroup::Av(), Foam::fvc::average(), layerAverage::average(), motionSmootherAlgo::avg(), snappySnapDriver::avgCellCentres(), GeometricBoundaryField< Type, GeoMesh, PrimitiveField >::boundaryInternalField(), GeometricBoundaryField< Type, GeoMesh, PrimitiveField >::boundaryNeighbourField(), cellMDLimitedGrad< Type >::calcGrad(), faceLimitedGrad< Type >::calcGrad(), faceMDLimitedGrad< Type >::calcGrad(), nutUSpaldingWallFunctionFvPatchScalarField::calcUTau(), Foam::meshCheck::cellDeterminant(), BasicThermo< MixtureType, BasicThermoType >::cellSetProperty(), cellPoint< Type >::cellVolumeWeightedSum(), MRFZoneList::centrifugalAcceleration(), Foam::meshCheck::checkCellDeterminant(), Foam::meshCheck::checkFaceOrthogonality(), Foam::meshCheck::checkFaceSkewness(), Foam::meshCheck::checkFaceWeight(), Foam::meshCheck::checkVolRatio(), filmCloudTransfer::CloudToFilmTransferRate(), Foam::cmptAv(), Foam::cmptMag(), Foam::cmptMax(), Foam::cmptMin(), fvPatch::Cn(), FieldField< Field, Type >::component(), Field< Type >::component(), isothermalFilm::constrainedField(), Foam::constrainHbyA(), Foam::constrainPhid(), Foam::constrainPhiHbyA(), box::coordinates(), collection::coordinates(), triSurface::coordinates(), PDRkEpsilon::correct(), massDiffusionLimitedPhaseChange::correct(), populationBalanceModel::correct(), kEpsilonLopesdaCosta< BasicMomentumTransportModel >::correct(), kOmegaSST< MomentumTransportModel, BasicMomentumTransportModel >::correct(), lambdaThixotropic< BasicMomentumTransportModel >::correct(), DeardorffDiffStress< BasicMomentumTransportModel >::correct(), SpalartAllmarasDES< BasicMomentumTransportModel >::correct(), kOmega< BasicMomentumTransportModel >::correct(), kOmega2006< BasicMomentumTransportModel >::correct(), LaunderSharmaKE< BasicMomentumTransportModel >::correct(), LRR< BasicMomentumTransportModel >::correct(), realizableKE< BasicMomentumTransportModel >::correct(), RNGkEpsilon< BasicMomentumTransportModel >::correct(), SpalartAllmaras< BasicMomentumTransportModel >::correct(), SSG< BasicMomentumTransportModel >::correct(), v2f< BasicMomentumTransportModel >::correct(), mixtureKEpsilon< BasicMomentumTransportModel >::correct(), correctedSnGrad< Type >::correction(), faceCorrectedSnGrad< Type >::correction(), linearUpwindV< Type >::correction(), CentredFitSnGradScheme< Type, Polynomial, Stencil >::correction(), cubic< Type >::correction(), outletStabilised< Type >::correction(), pointLinear< Type >::correction(), linearUpwind< Type >::correction(), multicomponentThermo::implementation::correctMassFractions(), kOmegaSSTLM< BasicMomentumTransportModel >::correctReThetatGammaInt(), Foam::fvc::curl(), displacementComponentLaplacianFvMotionSolver::curPoints(), velocityComponentLaplacianFvMotionSolver::curPoints(), displacementLaplacianFvMotionSolver::curPoints(), displacementSBRStressFvMotionSolver::curPoints(), velocityLaplacianFvMotionSolver::curPoints(), motionSmootherAlgo::curPoints(), displacementLinearMotionSolver::curPoints(), interpolatingSolidBodyMotionSolver::curPoints(), multiSolidBodyMotionSolver::curPoints(), solidBodyMotionSolver::curPoints(), triSurface::curvature(), wallBoiling::d(), fvMatrix< Type >::D(), wallDampingModel::damping(), basic::Dcu(), fvMatrix< Type >::DD(), MRFZoneList::DDt(), fvMesh::delta(), blackBodyEmission::deltaLambdaT(), nonlinearEddyViscosity< BasicMomentumTransportModel >::devTau(), mappedInternalPatchBase::distribute(), Foam::fvm::divc(), regionSizeDistribution::divide(), Fickian< BasicThermophysicalTransportModel >::divq(), MaxwellStefan< BasicThermophysicalTransportModel >::divq(), nonUnityLewisEddyDiffusivity< TurbulenceThermophysicalTransportModel >::divq(), blackBodyEmission::EbDeltaLambdaT(), greyMeanCombustion::ECont(), wideBandCombustion::ECont(), PatchTools::edgeNormals(), cloud::EDisp(), irregular::elevation(), ThermoCloud< CloudType >::Ep(), parcelCloudList::Ep(), atmBoundaryLayer::epsilon(), Foam::saturationModels::evaluate(), wallBoilingProperty::execute(), age::execute(), populationBalanceModel::expansionSp(), kOmegaSST< MomentumTransportModel, BasicMomentumTransportModel >::F23(), polyPatch::faceCellCentres(), Foam::meshCheck::faceConcavity(), Foam::meshCheck::faceFlatness(), lduMatrix::faceH(), Foam::meshCheck::faceOrthogonality(), Foam::meshCheck::faceSkewness(), PrimitivePatchInterpolation< Patch >::faceToEdgeInterpolate(), PrimitivePatchInterpolation< Patch >::faceToPointInterpolate(), Foam::meshCheck::faceWeights(), CloudDerivedField< Type >::field(), BasicThermo< MixtureType, BasicThermoType >::fieldSourceProperty(), VoFFilmTransfer::filmVoFTransferRate(), zoneCombustion::filter(), anisotropicFilter::filter(), surfaceFieldValue::filterField(), kOmegaSSTLM< BasicMomentumTransportModel >::Flength(), fvMatrix< Type >::flux(), forcing::forceCoeff(), fft::forwardTransform(), PsiuMulticomponentThermo< BaseThermo >::fres(), mappedPatchBase::fromNeighbour(), correctedSnGrad< Type >::fullGradCorrection(), faceCorrectedSnGrad< Type >::fullGradCorrection(), backwardDdtScheme< Type >::fvcDdt(), CoEulerDdtScheme< Type >::fvcDdt(), CrankNicolsonDdtScheme< Type >::fvcDdt(), EulerDdtScheme< Type >::fvcDdt(), SLTSDdtScheme< Type >::fvcDdt(), ddtScheme< Type >::fvcDdtPhiCoeff(), gaussConvectionScheme< Type >::fvcDiv(), gaussDivScheme< Type >::fvcDiv(), gaussLaplacianScheme< Type, GType >::fvcLaplacian(), EulerD2dt2Scheme< Type >::fvmD2dt2(), backwardDdtScheme< Type >::fvmDdt(), CoEulerDdtScheme< Type >::fvmDdt(), EulerDdtScheme< Type >::fvmDdt(), localEulerDdtScheme< Type >::fvmDdt(), SLTSDdtScheme< Type >::fvmDdt(), gaussConvectionScheme< Type >::fvmDiv(), gaussLaplacianScheme< Type, GType >::fvmLaplacian(), gaussLaplacianScheme< Type, GType >::fvmLaplacianUncorrected(), surfaceFieldValue::getFieldValues(), multiphaseCoupledTemperatureFvPatchScalarField::getNbr(), basic::Gk(), fvMatrix< Type >::H(), lduMatrix::H(), fvMatrix< Type >::H1(), lduMatrix::H1(), ThermalPhaseModel< BasePhaseModel >::heEqn(), parcelCloudList::hsCoeff(), parcelCloudList::hsTrans(), kappaEff::htcByRhoCp(), ReynoldsAnalogy::htcByRhoCp(), FieldFunction1< Type, Function1Type >::integral(), multiFixedValue::integralPDFxPow(), tabulatedCumulative::integralPDFxPow(), unintegrable::integrate(), unintegrable::integrateX(), twoPhaseMixture::interfaceFraction(), GAMGInterface::interfaceInternalField(), growthSizeGroupFvScalarFieldSource::internalCoeff(), cyclicGAMGInterface::internalFieldTransfer(), fieldInterpolation< Type, InterpolationType >::interpolate(), cutPolyIsoSurface::interpolate(), pointToPointPlanarInterpolation::interpolate(), vtkMesh::interpolate(), LagrangianAverage< Type >::interpolate(), surfaceInterpolationScheme< scalar >::interpolate(), singleCellFvMesh::interpolate(), surfaceInterpolationScheme< Type >::interpolate(), localMax< Type >::interpolate(), localMin< Type >::interpolate(), fvMeshSubset::interpolate(), volPointInterpolation::interpolate(), interfaceCompressionNew::interpolate(), PLIC::interpolate(), PLICU::interpolate(), patch::interpolateField(), thresholdCellFaces::interpolateField(), triSurface::interpolateField(), unintegrable::interpolateIntegrateXPow(), interpolation< Foam::Vector >::interpolation(), Foam::inv(), MaxwellStefan< BasicThermophysicalTransportModel >::j(), segregated::K(), SpalartAllmarasDES< BasicMomentumTransportModel >::k(), ReynoldsStress< BasicMomentumTransportModel >::k(), phaseSystem::K(), atmBoundaryLayer::k(), multiphaseVoFMixture::K(), ddtScheme< Type >::Lagrangianmddt(), CrankNicolson< Type >::LagrangianmDdt(), ddtScheme< Type >::Lagrangianmddt0(), CrankNicolson< Type >::LagrangianmNoDdt(), Explicit< Type, SpType >::LagrangianmSp(), implicit< Type, SpType >::LagrangianmSp(), Foam::levelSetFraction(), LimitedScheme< Type, Limiter, LimitFunc >::limiter(), PhiScheme< Type, PhiLimiter >::limiter(), Foam::mag(), Foam::magSqr(), Foam::fvc::magSqrGradGrad(), main(), timeVaryingMappedFvPatchField< Type >::map(), nonConformalMappedFvPatchBase::map(), fvFieldDecomposer::mapCellToFace(), fvFieldDecomposer::mapFaceToFace(), mappedValueFvPatchField< Type >::mappedValues(), phaseChange::mDot(), massDiffusionLimitedPhaseChange::mDot(), momentOfInertia::meshInertia(), fvMesh::movePoints(), primitiveMesh::movePoints(), wallBoiling::nDot(), phaseSystem::nearInterface(), multiphaseVoFMixture::nearInterface(), Foam::New(), LagrangianSubMesh::nf(), multicomponentThermo::implementation::normaliseY(), JohnsonJacksonSchaeffer::nu(), Schaeffer::nu(), strainRateFunction::nu(), nutkAtmRoughWallFunctionFvPatchScalarField::nut(), nutkRoughWallFunctionFvPatchScalarField::nut(), nutkWallFunctionFvPatchScalarField::nut(), nutURoughWallFunctionFvPatchScalarField::nut(), nutUWallFunctionFvPatchScalarField::nut(), consumptionSpeed::omega0Sigma(), inversePointDistanceDiffusivity::operator()(), RaviPetersen::operator()(), Foam::fvMeshStitcherTools::origNcMagSfb(), blendingMethod::parameter(), BasicThermo< MixtureType, BasicThermoType >::patchFieldProperty(), fvPatch::patchInternalField(), cyclicFvPatchField< Type >::patchNeighbourField(), cyclicFvsPatchField< Type >::patchNeighbourField(), noiseFFT::Pf(), specieTransferTemperatureFvPatchScalarField::phiHep(), specieTransferVelocityFvPatchVectorField::phip(), fixedValue::plotPDF(), multiFixedValue::plotPDF(), tabulatedCumulative::plotPDF(), tabulatedDensity::plotPDF(), distribution::plotX(), exponential::plotX(), fixedValue::plotX(), multiFixedValue::plotX(), normal::plotX(), RosinRammler::plotX(), standardNormal::plotX(), tabulatedCumulative::plotX(), tabulatedDensity::plotX(), PatchTools::pointNormals(), collection::points(), cylinder::points(), plate::points(), boundBox::points(), treeBoundBox::points(), PrimitivePatchInterpolation< Patch >::pointToFaceInterpolate(), cellPoint< Type >::pointVolumeWeightedSum(), LagrangianMesh::position(), blockEdge::position(), projectCurveEdge::position(), projectEdge::position(), Spline< Derived >::position(), Foam::pow(), compressibleMultiphaseVoF::pressureCorrector(), compressibleVoF::pressureCorrector(), sampledSurface::project(), compressibleMultiphaseVoFMixture::psiByRho(), Fickian< BasicThermophysicalTransportModel >::q(), MaxwellStefan< BasicThermophysicalTransportModel >::q(), nonUnityLewisEddyDiffusivity< TurbulenceThermophysicalTransportModel >::q(), chemistryModel< ThermoType >::Qdot(), nonlinearEddyViscosity< BasicMomentumTransportModel >::R(), EDC::R(), laminar::R(), compressibleMultiphaseVoFMixture::rCv(), chemistryModel< ThermoType >::reactionRR(), Foam::fvc::reconstruct(), lagrangianFieldReconstructor::reconstructField(), LagrangianFieldReconstructor::reconstructLagrangianPrimitiveField(), Foam::fvc::reconstructMag(), MRFZoneList::relative(), fvMatrix< Type >::residual(), LduMatrix< Type, DType, LUType >::residual(), lduMatrix::residual(), kOmegaSSTLM< BasicMomentumTransportModel >::ReThetac(), kOmegaSSTLM< BasicMomentumTransportModel >::ReThetat0(), fft::reverseTransform(), MomentumCloud< CloudType >::rhoEff(), fvDOM::Rp(), fvDOM::Ru(), FieldDistribution< Base, Derived >::sample(), patchProbes::sample(), probes::sample(), randomGenerator::sample01(), randomGenerator::sampleAB(), patch::sampleField(), patchInternalField::sampleField(), triSurface::sampleField(), sampledSets::sampleLocalType(), mappedInternalPatchBase::samplePoints(), randomGenerator::scalar01(), randomGenerator::scalarAB(), MulticomponentThermo< BaseThermo >::scalarFieldPropertyi(), forcing::scale(), waveSuperposition::scale(), ThermoCloud< CloudType >::Sh(), parcelCloudList::Sh(), temperatureDependent::sigma(), cloud::sigmaEff(), ThermoCloud< CloudType >::sigmap(), parcelCloudList::sigmap(), skewCorrected< Type >::skewCorrection(), snGradScheme< Type >::snGrad(), QRMatrix< MatrixType >::solve(), LLTMatrix< Type >::solve(), LUscalarMatrix::solve(), LagrangianModels::source(), LagrangianModels::sourceTerm(), fvModels::sourceTerm(), fvModel::sourceTerm(), SlicedGeometricField< Type, GeoMesh >::splice(), Foam::sqr(), fvMeshToFvMesh::srcToTgt(), ReactingCloud< CloudType >::Srho(), parcelCloudList::Srho(), Foam::stabilise(), objectRegistryFunctionObject::store(), MomentumCloud< CloudType >::SU(), parcelCloudList::SU(), layerAverage::sum(), MPLIC::surfaceAlpha(), Foam::fvc::surfaceIntegrate(), Foam::fvc::surfaceIntegrateExtrapolate(), Foam::fvc::surfaceSum(), phaseSystem::surfaceTension(), multiphaseVoFMixture::surfaceTensionForce(), ReactingCloud< CloudType >::SYi(), parcelCloudList::SYi(), DimensionedField< Type, GeoMesh, PrimitiveField >::T(), FieldField< Field, Type >::T(), Field< Type >::T(), GeometricField< Type, GeoMesh, PrimitiveField >::T(), chemistryModel< ThermoType >::tc(), phaseChange::Tchange(), targetCoeffTrim::thetag(), mappedPatchBase::toNeighbour(), sixDoFRigidBodyMotion::transform(), Foam::transform(), axesRotation::transformDiagTensor(), cylindrical::transformDiagTensor(), EulerCoordinateRotation::transformDiagTensor(), STARCDCoordinateRotation::transformDiagTensor(), Foam::transformPoints(), polynomialTemperature::Tsat(), polynomialTemperature::TsatPrime(), parcelCloudList::UCoeff(), LagrangianSubMesh::Uf(), waveAtmBoundaryLayerSuperposition::UGas(), waveVelocityFvPatchVectorField::Un(), parcelCloudList::UTrans(), FieldFunction1< Type, Function1Type >::value(), FieldFunction2< Type, Function2Type >::value(), MomentumCloud< CloudType >::vDotSweep(), irregular::velocity(), filmVoFTransfer::VoFToFilmTransferRate(), BasicThermo< MixtureType, BasicThermoType >::volInternalScalarFieldProperty(), MulticomponentThermo< BaseThermo >::volInternalScalarFieldPropertyi(), Foam::meshCheck::volRatio(), BasicThermo< MixtureType, BasicThermoType >::volScalarFieldProperty(), MulticomponentThermo< BaseThermo >::volScalarFieldPropertyi(), extendedFaceToCellStencil::weightedSum(), extendedCellToFaceStencil::weightedSum(), extendedUpwindCellToFaceStencil::weightedSum(), clippedLinear< Type >::weights(), midPoint< Type >::weights(), reverseLinear< Type >::weights(), limitedSurfaceInterpolationScheme< Type >::weights(), outletStabilised< Type >::weights(), noiseFFT::window(), populationBalanceSetSizeDistribution::write(), Table< Type >::x(), XiFluid::XiCorr(), SCOPEXiEq::XiEq(), MomentumCloud< CloudType >::Y(), Table< Type >::y(), nutURoughWallFunctionFvPatchScalarField::yPlus(), nutUWallFunctionFvPatchScalarField::yPlus(), alphatJayatillekeWallFunctionFvPatchScalarField::yPlusTherm(), wallLubricationModel::zeroGradWalls(), and Foam::zip().

Here is the call graph for this function:

◆ ptr()

◆ clear()

void clear
inline

If object pointer points to valid object:

delete object and set pointer to nullptr

Definition at line 253 of file tmpI.H.

Referenced by MRFZoneList::absolute(), lduMatrix::Amul(), PDRkEpsilon::correct(), kEpsilonLopesdaCosta< BasicMomentumTransportModel >::correct(), kOmegaSST< MomentumTransportModel, BasicMomentumTransportModel >::correct(), dynamicKEqn< BasicMomentumTransportModel >::correct(), kEqn< BasicMomentumTransportModel >::correct(), SpalartAllmarasDES< BasicMomentumTransportModel >::correct(), kOmega< BasicMomentumTransportModel >::correct(), LaunderSharmaKE< BasicMomentumTransportModel >::correct(), RNGkEpsilon< BasicMomentumTransportModel >::correct(), mixtureKEpsilon< BasicMomentumTransportModel >::correct(), kOmegaSSTLM< BasicMomentumTransportModel >::correctReThetatGammaInt(), Foam::fvc::DDt(), Foam::fvc::div(), Foam::fvm::div(), Foam::fvc::flux(), fft::forwardTransform(), GeometricField< Type, GeoMesh, PrimitiveField >::GeometricField(), surfaceInterpolationScheme< scalar >::interpolate(), main(), Field< Type >::map(), anisotropicFilter::operator()(), noiseFFT::Pf(), realizableKE< BasicMomentumTransportModel >::rCmu(), Foam::fvc::reconstructMag(), MRFZoneList::relative(), fft::reverseTransform(), Field< Type >::rmap(), snGradScheme< Type >::snGrad(), Foam::stabilise(), lduMatrix::Tmul(), Foam::transform(), Foam::transformPoints(), coneVelocityLagrangianVectorFieldSource::value(), phaseChange::vfToVif(), phaseChange::vifToVf(), and Foam::fvc::volumeIntegrate().

Here is the caller graph for this function:

◆ operator()()

const T & operator()
inline

Const dereference operator.

Definition at line 295 of file tmpI.H.

References Foam::abort(), Foam::FatalError, and FatalErrorInFunction.

Here is the call graph for this function:

◆ operator const T &()

operator const T &
inline

Const cast to the underlying type reference.

Definition at line 313 of file tmpI.H.

◆ operator->() [1/2]

T * operator->
inline

Return object pointer.

Definition at line 320 of file tmpI.H.

References Foam::abort(), Foam::FatalError, and FatalErrorInFunction.

Here is the call graph for this function:

◆ operator->() [2/2]

const T * operator->
inline

Return const object pointer.

Definition at line 343 of file tmpI.H.

References Foam::abort(), Foam::FatalError, and FatalErrorInFunction.

Here is the call graph for this function:

◆ operator=() [1/4]

void operator= ( T tPtr)
inline

Assignment to pointer changing this tmp to a temporary T.

Definition at line 357 of file tmpI.H.

References Foam::abort(), clear(), Foam::FatalError, and FatalErrorInFunction.

Here is the call graph for this function:

◆ operator=() [2/4]

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

Assignment transferring the temporary T to this tmp.

Definition at line 382 of file tmpI.H.

References Foam::abort(), clear(), Foam::FatalError, FatalErrorInFunction, Foam::name(), and Foam::T().

Here is the call graph for this function:

◆ operator=() [3/4]

void operator= ( tmp< T > &&  t)
inline

Move assignment transferring the temporary T to this tmp.

Definition at line 411 of file tmpI.H.

References clear().

Here is the call graph for this function:

◆ operator=() [4/4]

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

Move assignment transferring the temporary T to this tmp.

Definition at line 426 of file tmpI.H.

References clear().

Here is the call graph for this function:

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