Enable full gradient cacheing capability

This commit is contained in:
Hrvoje Jasak 2016-05-09 11:03:58 +01:00
parent 5c380a6de7
commit 8cf4b6fcd5
131 changed files with 650 additions and 513 deletions

View file

@ -137,8 +137,6 @@ int main(int argc, char *argv[])
)
+ HbyAblend*fvc::ddtPhiCorr(rrhoUA, rho, rhoU, phi);
p.boundaryField().updateCoeffs();
surfaceScalarField phiGradp =
rrhoUAf*mesh.magSf()*fvc::snGrad(p);

View file

@ -54,4 +54,5 @@
// Recalculate density
rho = thermo.rho();
rho.correctBoundaryConditions();
}

View file

@ -39,4 +39,5 @@
// Recalculate density
rho = thermo.rho();
rho.correctBoundaryConditions();
}

View file

@ -12,4 +12,5 @@
rho = Foam::min(rho, rhoMax);
rho = Foam::max(rho, rhoMin);
rho.relax();
rho.correctBoundaryConditions();
}

View file

@ -12,4 +12,5 @@
rho = Foam::min(rho, rhoMax);
rho = Foam::max(rho, rhoMin);
rho.relax();
rho.correctBoundaryConditions();
}

View file

@ -12,4 +12,5 @@
rho = Foam::min(rho, rhoMax);
rho = Foam::max(rho, rhoMin);
rho.relax();
rho.correctBoundaryConditions();
}

View file

@ -1,5 +1,4 @@
p.boundaryField().updateCoeffs();
{
volScalarField AU = UEqn().A();
U = UEqn().H()/AU;
@ -48,4 +47,4 @@
// Momentum corrector
U -= fvc::grad(p)/AU;
U.correctBoundaryConditions();
}

View file

@ -1,5 +1,4 @@
p.boundaryField().updateCoeffs();
{
volScalarField AU = UEqn().A();
U = UEqn().H()/AU;
@ -48,4 +47,4 @@
// Momentum corrector
U -= fvc::grad(p)/AU;
U.correctBoundaryConditions();
}

View file

@ -74,7 +74,6 @@ int main(int argc, char *argv[])
solve(UEqn() == -fvc::grad(p));
p.boundaryField().updateCoeffs();
volScalarField rAU = 1.0/UEqn().A();
U = rAU*UEqn().H();
UEqn.clear();

View file

@ -1,6 +1,4 @@
{
p.boundaryField().updateCoeffs();
// Prepare clean Ap without time derivative contribution and
// without contribution from under-relaxation
// HJ, 26/Oct/2015

View file

@ -1,5 +1,4 @@
p.boundaryField().updateCoeffs();
{
// Prepare clean 1/Ap without contribution from under-relaxation
// HJ, 26/Oct/2015
volScalarField rUA
@ -56,4 +55,4 @@
// re-used. HJ, 22/Jan/2016
U = UUrf*(U - rUA*fvc::grad(p)) + (1 - UUrf)*U.prevIter();
U.correctBoundaryConditions();
}

View file

@ -1,9 +1,9 @@
p.boundaryField().updateCoeffs();
{
volScalarField AU = UEqn().A();
U = UEqn().H()/AU;
UEqn.clear();
phi = fvc::interpolate(U) & mesh.Sf();
adjustPhi(phi, U, p);
// Non-orthogonal pressure corrector loop
@ -41,4 +41,4 @@
// Momentum corrector
U -= fvc::grad(p)/AU;
U.correctBoundaryConditions();
}

View file

@ -75,7 +75,6 @@ int main(int argc, char *argv[])
solve(UrelEqn() == -fvc::grad(p));
p.boundaryField().updateCoeffs();
volScalarField AUrel = UrelEqn().A();
Urel = UrelEqn().H()/AUrel;
UrelEqn.clear();

View file

@ -18,8 +18,6 @@
phiv = (fvc::interpolate(HbyA) & mesh.Sf())
+ fvc::ddtPhiCorr(rUA, rho, U, phiv);
p.boundaryField().updateCoeffs();
surfaceScalarField phiGradp = rUAf*mesh.magSf()*fvc::snGrad(p);
phiv -= phiGradp/rhof;

View file

@ -33,3 +33,6 @@
<< " Max(alpha1) = " << max(alpha1).value()
<< endl;
}
solve(fvm::ddt(rho) + fvc::div(rhoPhi));

View file

@ -79,7 +79,6 @@ int main(int argc, char *argv[])
solve(UEqn() == -fvc::grad(p));
p.boundaryField().updateCoeffs();
volScalarField rUA = 1.0/UEqn().A();
U = rUA*UEqn().H();
UEqn.clear();

View file

@ -198,7 +198,14 @@ Foam::coupledFvMatrix<Type>::solve(const dictionary& solverControls)
{
fvMatrix<Type>& curMatrix =
static_cast<fvMatrix<Type>& >(matrices[rowI]);
curMatrix.psi().internalField().replace(cmpt, psiCmpt[rowI]);
GeometricField<Type, fvPatchField, volMesh>& psiRef =
const_cast<GeometricField<Type, fvPatchField, volMesh>&>
(
curMatrix.psi()
);
psiRef.internalField().replace(cmpt, psiCmpt[rowI]);
curMatrix.diag() = saveDiag[rowI];
}
}
@ -206,9 +213,16 @@ Foam::coupledFvMatrix<Type>::solve(const dictionary& solverControls)
// Correct boundary conditions
forAll (matrices, rowI)
{
fvMatrix<Type>& curMatrix =
static_cast<fvMatrix<Type>& >(matrices[rowI]);
curMatrix.psi().correctBoundaryConditions();
const fvMatrix<Type>& curMatrix =
static_cast<const fvMatrix<Type>&>(matrices[rowI]);
GeometricField<Type, fvPatchField, volMesh>& psiRef =
const_cast<GeometricField<Type, fvPatchField, volMesh>&>
(
curMatrix.psi()
);
psiRef.correctBoundaryConditions();
}
return solverPerfVec;

View file

@ -69,11 +69,13 @@ coupledSolverPerformance coupledFvMatrix<scalar>::solve
static_cast<fvScalarMatrix&>(matrices[rowI]);
saveDiag.set(rowI, new scalarField(curMatrix.diag()));
// HR 17/Feb/2013
// Need to be able to compare references to support hacks
// such as in jumpCyclic
// psi.set(rowI, new scalarField(curMatrix.psi()));
psi.set(rowI, &curMatrix.psi());
// such as in jumpCyclic. HR 17/Feb/2013
scalarField& psiRef =
const_cast<scalarField&>(curMatrix.psi().internalField());
psi.set(rowI, &psiRef);
source.set(rowI, new scalarField(curMatrix.source()));
curMatrix.addBoundarySource(source[rowI], 0);
@ -114,27 +116,20 @@ coupledSolverPerformance coupledFvMatrix<scalar>::solve
solverPerf.print();
// HR 17/Feb/2013
// Not needed since reference is used
// Update solution
//forAll (matrices, rowI)
//{
// fvScalarMatrix& curMatrix =
// static_cast<fvScalarMatrix&>(matrices[rowI]);
//
// curMatrix.psi().internalField() = psi[rowI];
//}
// Correct boundary conditions
forAll (matrices, rowI)
{
fvScalarMatrix& curMatrix =
static_cast<fvScalarMatrix&>(matrices[rowI]);
const fvScalarMatrix& curMatrix =
static_cast<const fvScalarMatrix&>(matrices[rowI]);
curMatrix.psi().correctBoundaryConditions();
volScalarField& psiRef =
const_cast<volScalarField&>(curMatrix.psi());
psiRef.correctBoundaryConditions();
}
//HR 17.2.2013: Clear references to internal field without deleting the objects
// Clear references to internal field without deleting the objects
// HR 17.2.2013
forAll (matrices, rowI)
{
psi.set(rowI, NULL).ptr();

View file

@ -296,7 +296,7 @@ template<class Type>
tmp<fvMatrix<Type> >
EulerLocalDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
const objectRegistry& registry = this->mesh();
@ -342,7 +342,7 @@ tmp<fvMatrix<Type> >
EulerLocalDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
const objectRegistry& registry = this->mesh();
@ -386,7 +386,7 @@ tmp<fvMatrix<Type> >
EulerLocalDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
const objectRegistry& registry = this->mesh();

View file

@ -133,19 +133,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -399,7 +399,7 @@ template<class Type>
tmp<fvMatrix<Type> >
backwardDualDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
const objectRegistry& registry = this->mesh();
@ -479,7 +479,7 @@ tmp<fvMatrix<Type> >
backwardDualDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
const objectRegistry& registry = this->mesh();
@ -557,7 +557,7 @@ tmp<fvMatrix<Type> >
backwardDualDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
const objectRegistry& registry = this->mesh();

View file

@ -165,19 +165,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -190,7 +190,7 @@ void faMatrix<Type>::addBoundarySource
template<class Type>
faMatrix<Type>::faMatrix
(
GeometricField<Type, faPatchField, areaMesh>& psi,
const GeometricField<Type, faPatchField, areaMesh>& psi,
const dimensionSet& ds
)
:
@ -205,7 +205,7 @@ faMatrix<Type>::faMatrix
{
if (debug)
{
Info<< "faMatrix<Type>(GeometricField<Type, faPatchField, areaMesh>&,"
Info<< "faMatrix<Type>(const GeometricField<Type, faPatchField, areaMesh>&,"
" const dimensionSet&) : "
"constructing faMatrix<Type> for field " << psi_.name()
<< endl;
@ -235,7 +235,13 @@ faMatrix<Type>::faMatrix
);
}
psi_.boundaryField().updateCoeffs();
// Update the boundary coefficients of psi without changing its event No.
GeometricField<Type, faPatchField, areaMesh>& psiRef =
const_cast<GeometricField<Type, faPatchField, areaMesh>&>(psi_);
label currentStatePsi = psiRef.eventNo();
psiRef.boundaryField().updateCoeffs();
psiRef.eventNo() = currentStatePsi;
}
@ -273,7 +279,7 @@ faMatrix<Type>::faMatrix(const faMatrix<Type>& fam)
template<class Type>
faMatrix<Type>::faMatrix
(
GeometricField<Type, faPatchField, areaMesh>& psi,
const GeometricField<Type, faPatchField, areaMesh>& psi,
Istream& is
)
:
@ -288,7 +294,7 @@ faMatrix<Type>::faMatrix
{
if (debug)
{
Info<< "faMatrix<Type>(GeometricField<Type, faPatchField, areaMesh>&,"
Info<< "faMatrix<Type>(const GeometricField<Type, faPatchField, areaMesh>&,"
" Istream&) : "
"constructing faMatrix<Type> for field " << psi_.name()
<< endl;

View file

@ -71,7 +71,7 @@ class faMatrix
// Private data
// Reference to GeometricField<Type, faPatchField, areaMesh>
GeometricField<Type, faPatchField, areaMesh>& psi_;
const GeometricField<Type, faPatchField, areaMesh>& psi_;
//- Dimension set
dimensionSet dimensions_;
@ -189,7 +189,7 @@ public:
//- Construct given a field to solve for
faMatrix
(
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const dimensionSet&
);
@ -197,7 +197,11 @@ public:
faMatrix(const faMatrix<Type>&);
//- Construct from Istream given field to solve for
faMatrix(GeometricField<Type, faPatchField, areaMesh>&, Istream&);
faMatrix
(
const GeometricField<Type, faPatchField, areaMesh>&,
Istream&
);
// Destructor
@ -214,11 +218,6 @@ public:
return psi_;
}
GeometricField<Type, faPatchField, areaMesh>& psi()
{
return psi_;
}
const dimensionSet& dimensions() const
{
return dimensions_;

View file

@ -75,6 +75,10 @@ lduSolverPerformance faMatrix<Type>::solve(const dictionary& solverControls)
// HJ, 20/Nov/2007
lduInterfaceFieldPtrsList interfaces = psi_.boundaryField().interfaces();
// Cast into a non-const to solve. HJ, 6/May/2016
GeometricField<Type, faPatchField, areaMesh>& psi =
const_cast<GeometricField<Type, faPatchField, areaMesh>&>(psi_);
for (direction cmpt = 0; cmpt < Type::nComponents; cmpt++)
{
// copy field and source
@ -139,11 +143,11 @@ lduSolverPerformance faMatrix<Type>::solve(const dictionary& solverControls)
solverPerfVec = solverPerf;
}
psi_.internalField().replace(cmpt, psiCmpt);
psi.internalField().replace(cmpt, psiCmpt);
diag() = saveDiag;
}
psi_.correctBoundaryConditions();
psi.correctBoundaryConditions();
return solverPerfVec;
}

View file

@ -113,14 +113,22 @@ lduSolverPerformance faMatrix<scalar>::faSolver::solve
faMat_.addBoundarySource(totalSource, false);
solver_->read(solverControls);
// Cast into a non-const to solve. HJ, 6/May/2016
GeometricField<scalar, faPatchField, areaMesh>& psi =
const_cast<GeometricField<scalar, faPatchField, areaMesh>&>
(
faMat_.psi()
);
lduSolverPerformance solverPerf =
solver_->solve(faMat_.psi().internalField(), totalSource);
solver_->solve(psi.internalField(), totalSource);
solverPerf.print();
faMat_.diag() = saveDiag;
faMat_.psi().correctBoundaryConditions();
psi.correctBoundaryConditions();
return solverPerf;
}
@ -139,6 +147,9 @@ lduSolverPerformance faMatrix<scalar>::solve
<< endl;
}
GeometricField<scalar, faPatchField, areaMesh>& psi =
const_cast<GeometricField<scalar, faPatchField, areaMesh>&>(psi_);
scalarField saveDiag = diag();
addBoundaryDiag(diag(), 0);
@ -158,13 +169,13 @@ lduSolverPerformance faMatrix<scalar>::solve
internalCoeffs_,
interfaces,
solverControls
)->solve(psi_.internalField(), totalSource);
)->solve(psi.internalField(), totalSource);
solverPerf.print();
diag() = saveDiag;
psi_.correctBoundaryConditions();
psi.correctBoundaryConditions();
return solverPerf;
}

View file

@ -143,7 +143,7 @@ public:
virtual tmp<faMatrix<Type> > famDiv
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
) const = 0;
virtual tmp<GeometricField<Type, faPatchField, areaMesh> > facDiv

View file

@ -58,7 +58,7 @@ tmp<faMatrix<Type> >
gaussConvectionScheme<Type>::famDiv
(
const edgeScalarField& faceFlux,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
) const
{
tmp<edgeScalarField> tweights = tinterpScheme_().weights(vf);

View file

@ -117,7 +117,7 @@ public:
tmp<faMatrix<Type> > famDiv
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
) const;
tmp<GeometricField<Type, faPatchField, areaMesh> > facDiv

View file

@ -501,7 +501,7 @@ template<class Type>
tmp<faMatrix<Type> >
EulerFaDdtScheme<Type>::famDdt
(
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam
@ -537,7 +537,7 @@ tmp<faMatrix<Type> >
EulerFaDdtScheme<Type>::famDdt
(
const dimensionedScalar& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam
@ -574,7 +574,7 @@ tmp<faMatrix<Type> >
EulerFaDdtScheme<Type>::famDdt
(
const areaScalarField& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam

View file

@ -146,19 +146,19 @@ public:
tmp<faMatrix<Type> > famDdt
(
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
tmp<faMatrix<Type> > famDdt
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
tmp<faMatrix<Type> > famDdt
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
};

View file

@ -700,7 +700,7 @@ template<class Type>
tmp<faMatrix<Type> >
backwardFaDdtScheme<Type>::famDdt
(
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam
@ -752,7 +752,7 @@ tmp<faMatrix<Type> >
backwardFaDdtScheme<Type>::famDdt
(
const dimensionedScalar& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam
@ -803,7 +803,7 @@ tmp<faMatrix<Type> >
backwardFaDdtScheme<Type>::famDdt
(
const areaScalarField& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam

View file

@ -157,19 +157,19 @@ public:
tmp<faMatrix<Type> > famDdt
(
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
tmp<faMatrix<Type> > famDdt
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
tmp<faMatrix<Type> > famDdt
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
};

View file

@ -819,7 +819,7 @@ boundedBackwardFaDdtScheme::facDdt0
tmp<faScalarMatrix>
boundedBackwardFaDdtScheme::famDdt
(
areaScalarField& vf
const areaScalarField& vf
)
{
tmp<faScalarMatrix> tfam
@ -890,7 +890,7 @@ tmp<faScalarMatrix>
boundedBackwardFaDdtScheme::famDdt
(
const dimensionedScalar& rho,
areaScalarField& vf
const areaScalarField& vf
)
{
tmp<faScalarMatrix> tfam
@ -960,7 +960,7 @@ tmp<faScalarMatrix>
boundedBackwardFaDdtScheme::famDdt
(
const areaScalarField& rho,
areaScalarField& vf
const areaScalarField& vf
)
{
tmp<faScalarMatrix> tfam

View file

@ -168,19 +168,19 @@ public:
tmp<faScalarMatrix> famDdt
(
areaScalarField&
const areaScalarField&
);
tmp<faScalarMatrix> famDdt
(
const dimensionedScalar&,
areaScalarField&
const areaScalarField&
);
tmp<faScalarMatrix> famDdt
(
const areaScalarField&,
areaScalarField&
const areaScalarField&
);
};

View file

@ -190,19 +190,19 @@ public:
virtual tmp<faMatrix<Type> > famDdt
(
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
) = 0;
virtual tmp<faMatrix<Type> > famDdt
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
) = 0;
virtual tmp<faMatrix<Type> > famDdt
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
) = 0;
};

View file

@ -308,7 +308,7 @@ template<class Type>
tmp<faMatrix<Type> >
steadyStateFaDdtScheme<Type>::famDdt
(
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam
@ -329,7 +329,7 @@ tmp<faMatrix<Type> >
steadyStateFaDdtScheme<Type>::famDdt
(
const dimensionedScalar& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam
@ -350,7 +350,7 @@ tmp<faMatrix<Type> >
steadyStateFaDdtScheme<Type>::famDdt
(
const areaScalarField& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam

View file

@ -145,19 +145,19 @@ public:
tmp<faMatrix<Type> > famDdt
(
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
tmp<faMatrix<Type> > famDdt
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
tmp<faMatrix<Type> > famDdt
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
};

View file

@ -162,17 +162,16 @@ public:
// Add the patch constructor functions to the hash tables
#define makeFaDivTypeScheme(SS, Type) \
\
defineNamedTemplateTypeNameAndDebug(SS<Type>, 0); \
\
divScheme<Type>::addIstreamConstructorToTable<SS<Type> > \
#define makeFaDivTypeScheme(SS, Type) \
\
defineNamedTemplateTypeNameAndDebug(SS<Type>, 0); \
\
divScheme<Type>::addIstreamConstructorToTable<SS<Type> > \
add##SS##Type##IstreamConstructorToTable_;
#define makeFaDivScheme(SS) \
\
makeFaDivTypeScheme(SS, vector) \
#define makeFaDivScheme(SS) \
\
makeFaDivTypeScheme(SS, vector) \
makeFaDivTypeScheme(SS, tensor)

View file

@ -44,7 +44,7 @@ template<class Type>
tmp<faMatrix<Type> >
ddt
(
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
return fa::faDdtScheme<Type>::New
@ -60,7 +60,7 @@ tmp<faMatrix<Type> >
ddt
(
const dimensionedScalar& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
return fa::faDdtScheme<Type>::New
@ -79,7 +79,7 @@ tmp<faMatrix<Type> >
ddt
(
const areaScalarField& rho,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
return fa::faDdtScheme<Type>::New

View file

@ -52,21 +52,21 @@ namespace fam
template<class Type>
tmp<faMatrix<Type> > ddt
(
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > ddt
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > ddt
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
}

View file

@ -45,7 +45,7 @@ tmp<faMatrix<Type> >
div
(
const edgeScalarField& flux,
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -62,7 +62,7 @@ tmp<faMatrix<Type> >
div
(
const tmp<edgeScalarField>& tflux,
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -77,7 +77,7 @@ tmp<faMatrix<Type> >
div
(
const edgeScalarField& flux,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
return fam::div(flux, vf, "div("+flux.name()+','+vf.name()+')');
@ -88,7 +88,7 @@ tmp<faMatrix<Type> >
div
(
const tmp<edgeScalarField>& tflux,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > Div(fam::div(tflux(), vf));

View file

@ -55,7 +55,7 @@ namespace fam
tmp<faMatrix<Type> > div
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word& name
);
@ -63,7 +63,7 @@ namespace fam
tmp<faMatrix<Type> > div
(
const tmp<edgeScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word& name
);
@ -71,14 +71,14 @@ namespace fam
tmp<faMatrix<Type> > div
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > div
(
const tmp<edgeScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
}

View file

@ -45,7 +45,7 @@ template<class Type>
tmp<faMatrix<Type> >
laplacian
(
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
edgeScalarField Gamma
@ -69,7 +69,7 @@ template<class Type>
tmp<faMatrix<Type> >
laplacian
(
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -95,7 +95,7 @@ tmp<faMatrix<Type> >
laplacian
(
const dimensionedScalar& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
edgeScalarField Gamma
@ -120,7 +120,7 @@ tmp<faMatrix<Type> >
laplacian
(
const dimensionedScalar& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -146,7 +146,7 @@ tmp<faMatrix<Type> >
laplacian
(
const areaScalarField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
return fam::laplacian
@ -163,7 +163,7 @@ tmp<faMatrix<Type> >
laplacian
(
const areaScalarField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -180,7 +180,7 @@ tmp<faMatrix<Type> >
laplacian
(
const tmp<areaScalarField>& tgamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > Laplacian(fam::laplacian(tgamma(), vf));
@ -194,7 +194,7 @@ tmp<faMatrix<Type> >
laplacian
(
const tmp<areaScalarField>& tgamma,
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -209,7 +209,7 @@ tmp<faMatrix<Type> >
laplacian
(
const edgeScalarField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -226,7 +226,7 @@ tmp<faMatrix<Type> >
laplacian
(
const tmp<edgeScalarField>& tgamma,
GeometricField<Type, faPatchField, areaMesh>& vf,
const GeometricField<Type, faPatchField, areaMesh>& vf,
const word& name
)
{
@ -241,7 +241,7 @@ tmp<faMatrix<Type> >
laplacian
(
const edgeScalarField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
return fam::laplacian
@ -257,7 +257,7 @@ tmp<faMatrix<Type> >
laplacian
(
const tmp<edgeScalarField>& tgamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam(fam::laplacian(tgamma(), vf));
@ -271,7 +271,7 @@ tmp<faMatrix<Type> >
laplacian
(
const areaTensorField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
const faMesh& mesh = vf.mesh();
@ -289,7 +289,7 @@ tmp<faMatrix<Type> >
laplacian
(
const tmp<areaTensorField>& tgamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > Laplacian = fam::laplacian(tgamma(), vf);
@ -303,7 +303,7 @@ tmp<faMatrix<Type> >
laplacian
(
const edgeTensorField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
const faMesh& mesh = vf.mesh();
@ -320,7 +320,7 @@ tmp<faMatrix<Type> >
laplacian
(
const tmp<edgeTensorField>& tgamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > Laplacian = fam::laplacian(tgamma(), vf);

View file

@ -53,14 +53,14 @@ namespace fam
template<class Type>
tmp<faMatrix<Type> > laplacian
(
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > laplacian
(
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word&
);
@ -69,7 +69,7 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
@ -77,7 +77,7 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word&
);
@ -86,14 +86,14 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > laplacian
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word&
);
@ -101,21 +101,21 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > laplacian
(
const tmp<areaScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word&
);
template<class Type>
tmp<faMatrix<Type> > laplacian
(
const tmp<areaScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word&
);
@ -124,7 +124,7 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word&
);
@ -132,7 +132,7 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const tmp<edgeScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&,
const GeometricField<Type, faPatchField, areaMesh>&,
const word&
);
@ -141,14 +141,14 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > laplacian
(
const tmp<edgeScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
@ -156,14 +156,14 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const areaTensorField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > laplacian
(
const tmp<areaTensorField>&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
@ -171,14 +171,14 @@ namespace fam
tmp<faMatrix<Type> > laplacian
(
const edgeTensorField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > laplacian
(
const tmp<edgeTensorField>&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
}

View file

@ -47,7 +47,7 @@ tmp<faMatrix<Type> >
Su
(
const GeometricField<Type, faPatchField, areaMesh>& su,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
const faMesh& mesh = vf.mesh();
@ -72,7 +72,7 @@ tmp<faMatrix<Type> >
Su
(
const tmp<GeometricField<Type, faPatchField, areaMesh> >& tsu,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam = fam::Su(tsu(), vf);
@ -86,7 +86,7 @@ tmp<faMatrix<Type> >
Sp
(
const areaScalarField& sp,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
const faMesh& mesh = vf.mesh();
@ -111,7 +111,7 @@ tmp<faMatrix<Type> >
Sp
(
const tmp<areaScalarField>& tsp,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam = fam::Sp(tsp(), vf);
@ -125,7 +125,7 @@ tmp<faMatrix<Type> >
Sp
(
const dimensionedScalar& sp,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
const faMesh& mesh = vf.mesh();
@ -151,7 +151,7 @@ tmp<faMatrix<Type> >
SuSp
(
const areaScalarField& sp,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
const faMesh& mesh = vf.mesh();
@ -179,7 +179,7 @@ tmp<faMatrix<Type> >
SuSp
(
const tmp<areaScalarField>& tsp,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<faMatrix<Type> > tfam = fam::SuSp(tsp(), vf);

View file

@ -55,14 +55,14 @@ namespace fam
tmp<faMatrix<Type> > Su
(
const GeometricField<Type, faPatchField, areaMesh>&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > Su
(
const tmp<GeometricField<Type, faPatchField, areaMesh> >&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
@ -72,14 +72,14 @@ namespace fam
tmp<faMatrix<Type> > Sp
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > Sp
(
const tmp<areaScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
@ -87,7 +87,7 @@ namespace fam
tmp<faMatrix<Type> > Sp
(
const dimensionedScalar&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
@ -97,14 +97,14 @@ namespace fam
tmp<faMatrix<Type> > SuSp
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
template<class Type>
tmp<faMatrix<Type> > SuSp
(
const tmp<areaScalarField>&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
}

View file

@ -103,7 +103,7 @@ tmp<faMatrix<Type> >
laplacianScheme<Type>::famLaplacian
(
const areaScalarField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
return famLaplacian(tinterpGammaScheme_().interpolate(gamma)(), vf);

View file

@ -171,13 +171,13 @@ public:
virtual tmp<faMatrix<Type> > famLaplacian
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
) = 0;
virtual tmp<faMatrix<Type> > famLaplacian
(
const areaScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
virtual tmp<GeometricField<Type, faPatchField, areaMesh> > facLaplacian

View file

@ -44,7 +44,7 @@ tmp<faMatrix<Type> >
gaussLaplacianScheme<Type>::famLaplacian
(
const edgeScalarField& gamma,
GeometricField<Type, faPatchField, areaMesh>& vf
const GeometricField<Type, faPatchField, areaMesh>& vf
)
{
tmp<edgeScalarField> tdeltaCoeffs = this->tlnGradScheme_().deltaCoeffs(vf);

View file

@ -92,7 +92,7 @@ public:
tmp<faMatrix<Type> > famLaplacian
(
const edgeScalarField&,
GeometricField<Type, faPatchField, areaMesh>&
const GeometricField<Type, faPatchField, areaMesh>&
);
tmp<GeometricField<Type, faPatchField, areaMesh> > facLaplacian

View file

@ -45,12 +45,12 @@ bool Foam::adjustPhi
(
surfaceScalarField& phi,
const volVectorField& U,
volScalarField& p
const volScalarField& p
)
{
if (p.needReference())
{
p.boundaryField().updateCoeffs();
// Removed updateCoeffs. HJ, 9/May/2016
scalar massIn = 0.0;
scalar fixedMassOut = 0.0;

View file

@ -51,7 +51,7 @@ bool adjustPhi
(
surfaceScalarField& phi,
const volVectorField& U,
volScalarField& p
const volScalarField& p
);
} // End namespace Foam

View file

@ -242,7 +242,7 @@ void Foam::fvPatchField<Type>::evaluate(const Pstream::commsTypes)
template<class Type>
void Foam::fvPatchField<Type>::manipulateMatrix(fvMatrix<Type>& matrix)
void Foam::fvPatchField<Type>::manipulateMatrix(fvMatrix<Type>& matrix) const
{
// do nothing
}

View file

@ -463,7 +463,7 @@ public:
// Matrix manipulation
//- Manipulate matrix
virtual void manipulateMatrix(fvMatrix<Type>& matrix);
virtual void manipulateMatrix(fvMatrix<Type>& matrix) const;
// I-O

View file

@ -136,7 +136,7 @@ public:
virtual tmp<fvMatrix<Type> > fvmAdjDiv
(
const volVectorField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const = 0;
virtual tmp<GeometricField<Type, fvPatchField, volMesh> > fvcAdjDiv

View file

@ -45,7 +45,7 @@ tmp<fvMatrix<Type> >
explicitAdjConvectionScheme<Type>::fvmAdjDiv
(
const volVectorField& Up,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
) const
{
tmp<fvMatrix<Type> > tfvm

View file

@ -104,7 +104,7 @@ public:
tmp<fvMatrix<Type> > fvmAdjDiv
(
const volVectorField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const;
tmp<GeometricField<Type, fvPatchField, volMesh> > fvcAdjDiv

View file

@ -45,7 +45,7 @@ tmp<fvMatrix<Type> >
noAdjConvectionScheme<Type>::fvmAdjDiv
(
const volVectorField& Up,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
) const
{
tmp<fvMatrix<Type> > tfvm

View file

@ -104,7 +104,7 @@ public:
tmp<fvMatrix<Type> > fvmAdjDiv
(
const volVectorField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const;
tmp<GeometricField<Type, fvPatchField, volMesh> > fvcAdjDiv

View file

@ -176,7 +176,7 @@ public:
virtual tmp<fvMatrix<Type> > fvmDiv
(
const surfaceScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const = 0;
virtual tmp<GeometricField<Type, fvPatchField, volMesh> > fvcDiv

View file

@ -68,7 +68,7 @@ tmp<fvMatrix<Type> >
explicitConvectionScheme<Type>::fvmDiv
(
const surfaceScalarField& faceFlux,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
) const
{
tmp<fvMatrix<Type> > tfvm

View file

@ -127,7 +127,7 @@ public:
tmp<fvMatrix<Type> > fvmDiv
(
const surfaceScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const;
tmp<GeometricField<Type, fvPatchField, volMesh> > fvcDiv

View file

@ -68,7 +68,7 @@ tmp<fvMatrix<Type> >
gaussConvectionScheme<Type>::fvmDiv
(
const surfaceScalarField& faceFlux,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
) const
{
tmp<surfaceScalarField> tweights = tinterpScheme_().weights(vf);

View file

@ -123,7 +123,7 @@ public:
tmp<fvMatrix<Type> > fvmDiv
(
const surfaceScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const;
tmp<GeometricField<Type, fvPatchField, volMesh> > fvcDiv

View file

@ -80,7 +80,7 @@ tmp<fvMatrix<Type> >
multivariateGaussConvectionScheme<Type>::fvmDiv
(
const surfaceScalarField& faceFlux,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
) const
{
return gaussConvectionScheme<Type>

View file

@ -113,7 +113,7 @@ public:
tmp<fvMatrix<Type> > fvmDiv
(
const surfaceScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const;
tmp<GeometricField<Type, fvPatchField, volMesh> > fvcDiv

View file

@ -86,7 +86,7 @@ tmp<fvMatrix<Type> >
noConvectionScheme<Type>::fvmDiv
(
const surfaceScalarField& faceFlux,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
) const
{
tmp<fvMatrix<Type> > tfvm

View file

@ -117,7 +117,7 @@ public:
tmp<fvMatrix<Type> > fvmDiv
(
const surfaceScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) const;
tmp<GeometricField<Type, fvPatchField, volMesh> > fvcDiv

View file

@ -231,7 +231,7 @@ template<class Type>
tmp<fvMatrix<Type> >
EulerD2dt2Scheme<Type>::fvmD2dt2
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -291,7 +291,7 @@ tmp<fvMatrix<Type> >
EulerD2dt2Scheme<Type>::fvmD2dt2
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -352,7 +352,7 @@ tmp<fvMatrix<Type> >
EulerD2dt2Scheme<Type>::fvmD2dt2
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -108,19 +108,19 @@ public:
tmp<fvMatrix<Type> > fvmD2dt2
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmD2dt2
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmD2dt2
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
};

View file

@ -55,7 +55,10 @@ scalar backwardD2dt2Scheme<Type>::deltaT0_() const
template<class Type>
scalar backwardD2dt2Scheme<Type>::deltaT0_(GeometricField<Type, fvPatchField, volMesh>& vf) const
scalar backwardD2dt2Scheme<Type>::deltaT0_
(
const GeometricField<Type, fvPatchField, volMesh>& vf
) const
{
// Bug fix, Zeljko Tukovic: solver with outer iterations over a time-step
// HJ, 12/Feb/2010
@ -228,7 +231,7 @@ template<class Type>
tmp<fvMatrix<Type> >
backwardD2dt2Scheme<Type>::fvmD2dt2
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -256,7 +259,7 @@ backwardD2dt2Scheme<Type>::fvmD2dt2
notImplemented
(
type()
+ "::fvmD2dt2(GeometricField<Type, fvPatchField, volMesh>& vf)"
+ "::fvmD2dt2(const GeometricField<Type, fvPatchField, volMesh>& vf)"
);
}
else
@ -284,7 +287,7 @@ tmp<fvMatrix<Type> >
backwardD2dt2Scheme<Type>::fvmD2dt2
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -315,7 +318,7 @@ backwardD2dt2Scheme<Type>::fvmD2dt2
+ "::fvcD2dt2"
+ "("
+ "const dimensionedScalar& rho, "
+ "GeometricField<Type, fvPatchField, volMesh>& vf"
+ "const GeometricField<Type, fvPatchField, volMesh>& vf"
+ ")"
);
}
@ -339,7 +342,7 @@ tmp<fvMatrix<Type> >
backwardD2dt2Scheme<Type>::fvmD2dt2
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -67,7 +67,10 @@ class backwardD2dt2Scheme
//- Return the previous time-step or GREAT if the old timestep field
// wasn't available in which case Euler ddt is used
scalar deltaT0_(GeometricField<Type, fvPatchField, volMesh>&) const;
scalar deltaT0_
(
const GeometricField<Type, fvPatchField, volMesh>&
) const;
//- Disallow default bitwise copy construct
backwardD2dt2Scheme(const backwardD2dt2Scheme&);
@ -118,19 +121,19 @@ public:
tmp<fvMatrix<Type> > fvmD2dt2
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmD2dt2
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmD2dt2
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
};

View file

@ -152,19 +152,19 @@ public:
virtual tmp<fvMatrix<Type> > fvmD2dt2
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) = 0;
virtual tmp<fvMatrix<Type> > fvmD2dt2
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) = 0;
virtual tmp<fvMatrix<Type> > fvmD2dt2
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) = 0;
};

View file

@ -106,7 +106,7 @@ template<class Type>
tmp<fvMatrix<Type> >
steadyStateD2dt2Scheme<Type>::fvmD2dt2
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -127,7 +127,7 @@ tmp<fvMatrix<Type> >
steadyStateD2dt2Scheme<Type>::fvmD2dt2
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -148,7 +148,7 @@ tmp<fvMatrix<Type> >
steadyStateD2dt2Scheme<Type>::fvmD2dt2
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -107,19 +107,19 @@ public:
tmp<fvMatrix<Type> > fvmD2dt2
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmD2dt2
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmD2dt2
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
};

View file

@ -368,7 +368,7 @@ template<class Type>
tmp<fvMatrix<Type> >
CoEulerDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -404,7 +404,7 @@ tmp<fvMatrix<Type> >
CoEulerDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -441,7 +441,7 @@ tmp<fvMatrix<Type> >
CoEulerDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -141,19 +141,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -624,7 +624,7 @@ template<class Type>
tmp<fvMatrix<Type> >
CrankNicolsonDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
DDt0Field<GeometricField<Type, fvPatchField, volMesh> >& ddt0 =
@ -708,7 +708,7 @@ tmp<fvMatrix<Type> >
CrankNicolsonDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
DDt0Field<GeometricField<Type, fvPatchField, volMesh> >& ddt0 =
@ -790,7 +790,7 @@ tmp<fvMatrix<Type> >
CrankNicolsonDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
DDt0Field<GeometricField<Type, fvPatchField, volMesh> >& ddt0 =

View file

@ -212,19 +212,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -261,7 +261,7 @@ template<class Type>
tmp<fvMatrix<Type> >
EulerDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -297,7 +297,7 @@ tmp<fvMatrix<Type> >
EulerDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -334,7 +334,7 @@ tmp<fvMatrix<Type> >
EulerDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -119,19 +119,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -371,7 +371,7 @@ template<class Type>
tmp<fvMatrix<Type> >
SLTSDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -409,7 +409,7 @@ tmp<fvMatrix<Type> >
SLTSDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -446,7 +446,7 @@ tmp<fvMatrix<Type> >
SLTSDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -142,19 +142,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -362,7 +362,7 @@ template<class Type>
tmp<fvMatrix<Type> >
backwardDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -414,7 +414,7 @@ tmp<fvMatrix<Type> >
backwardDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -465,7 +465,7 @@ tmp<fvMatrix<Type> >
backwardDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -130,19 +130,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -412,7 +412,7 @@ boundedBackwardDdtScheme::fvcDdt
tmp<fvScalarMatrix>
boundedBackwardDdtScheme::fvmDdt
(
volScalarField& vf
const volScalarField& vf
)
{
tmp<fvScalarMatrix> tfvm
@ -483,7 +483,7 @@ tmp<fvScalarMatrix>
boundedBackwardDdtScheme::fvmDdt
(
const dimensionedScalar& rho,
volScalarField& vf
const volScalarField& vf
)
{
tmp<fvScalarMatrix> tfvm
@ -553,7 +553,7 @@ tmp<fvScalarMatrix>
boundedBackwardDdtScheme::fvmDdt
(
const volScalarField& rho,
volScalarField& vf
const volScalarField& vf
)
{
tmp<fvScalarMatrix> tfvm

View file

@ -141,19 +141,19 @@ public:
tmp<fvScalarMatrix> fvmDdt
(
volScalarField&
const volScalarField&
);
tmp<fvScalarMatrix> fvmDdt
(
const dimensionedScalar&,
volScalarField&
const volScalarField&
);
tmp<fvScalarMatrix> fvmDdt
(
const volScalarField&,
volScalarField&
const volScalarField&
);
tmp<surfaceScalarField> fvcDdtPhiCorr

View file

@ -163,19 +163,19 @@ public:
virtual tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) = 0;
virtual tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) = 0;
virtual tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
) = 0;

View file

@ -373,7 +373,7 @@ template<class Type>
tmp<fvMatrix<Type> >
steadyInertialDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -409,7 +409,7 @@ tmp<fvMatrix<Type> >
steadyInertialDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -446,7 +446,7 @@ tmp<fvMatrix<Type> >
steadyInertialDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -142,19 +142,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -161,7 +161,7 @@ template<class Type>
tmp<fvMatrix<Type> >
steadyStateDdtScheme<Type>::fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -182,7 +182,7 @@ tmp<fvMatrix<Type> >
steadyStateDdtScheme<Type>::fvmDdt
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm
@ -203,7 +203,7 @@ tmp<fvMatrix<Type> >
steadyStateDdtScheme<Type>::fvmDdt
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > tfvm

View file

@ -118,19 +118,19 @@ public:
tmp<fvMatrix<Type> > fvmDdt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
tmp<fvMatrix<Type> > fvmDdt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
typedef typename ddtScheme<Type>::fluxFieldType fluxFieldType;

View file

@ -112,7 +112,7 @@ divScheme<Type>::fvmUDiv
(
"tmp<BlockLduSystem> divScheme<Type>::fvmDiv\n"
"(\n"
" GeometricField<Type, fvPatchField, volMesh>&"
" const GeometricField<Type, fvPatchField, volMesh>&"
")\n"
) << "Implicit div operator currently defined only for Gauss linear. "
<< abort(FatalError);
@ -144,7 +144,7 @@ divScheme<Type>::fvmUDiv
"tmp<BlockLduSystem> divScheme<Type>::fvmDiv\n"
"(\n"
" surfaceScalarField&"
" GeometricField<Type, fvPatchField, volMesh>&"
" const GeometricField<Type, fvPatchField, volMesh>&"
")\n"
) << "Implicit div operator currently defined only for Gauss linear. "
<< abort(FatalError);

View file

@ -43,7 +43,7 @@ tmp<fvMatrix<Type> >
adjDiv
(
const volVectorField& Up,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -60,7 +60,7 @@ tmp<fvMatrix<Type> >
adjDiv
(
const tmp<volVectorField>& tUp,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -75,7 +75,7 @@ tmp<fvMatrix<Type> >
adjDiv
(
const volVectorField& Up,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
return fvm::adjDiv(Up, vf, "adjDiv("+Up.name()+','+vf.name()+')');
@ -86,7 +86,7 @@ tmp<fvMatrix<Type> >
adjDiv
(
const tmp<volVectorField>& tUp,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > AdjDiv(fvm::adjDiv(tUp(), vf));

View file

@ -55,7 +55,7 @@ namespace fvm
tmp<fvMatrix<Type> > adjDiv
(
const volVectorField&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
@ -63,7 +63,7 @@ namespace fvm
tmp<fvMatrix<Type> > adjDiv
(
const tmp<volVectorField>&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
@ -72,14 +72,14 @@ namespace fvm
tmp<fvMatrix<Type> > adjDiv
(
const volVectorField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
template<class Type>
tmp<fvMatrix<Type> > adjDiv
(
const tmp<volVectorField>&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
}

View file

@ -44,7 +44,7 @@ template<class Type>
tmp<fvMatrix<Type> >
d2dt2
(
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -61,7 +61,7 @@ tmp<fvMatrix<Type> >
d2dt2
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -78,7 +78,7 @@ tmp<fvMatrix<Type> >
d2dt2
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -94,7 +94,7 @@ template<class Type>
tmp<fvMatrix<Type> >
d2dt2
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
return fvm::d2dt2(vf, "d2dt2(" + vf.name() + ')');
@ -106,7 +106,7 @@ tmp<fvMatrix<Type> >
d2dt2
(
const dimensionedScalar& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
return fvm::d2dt2(rho, vf, "d2dt2(" + rho.name() + ',' + vf.name() + ')');
@ -118,7 +118,7 @@ tmp<fvMatrix<Type> >
d2dt2
(
const volScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
return fvm::d2dt2(rho, vf, "d2dt2(" + rho.name() + ',' + vf.name() + ')');

View file

@ -53,14 +53,14 @@ namespace fvm
tmp<fvMatrix<Type> > d2dt2
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
template<class Type>
tmp<fvMatrix<Type> > d2dt2
(
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
@ -68,7 +68,7 @@ namespace fvm
tmp<fvMatrix<Type> > d2dt2
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
@ -76,21 +76,21 @@ namespace fvm
tmp<fvMatrix<Type> > d2dt2
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
template<class Type>
tmp<fvMatrix<Type> > d2dt2
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
template<class Type>
tmp<fvMatrix<Type> > d2dt2
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
}

View file

@ -53,7 +53,7 @@ namespace fvm
template<class Type>
tmp<fvMatrix<Type> > ddt
(
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
@ -61,7 +61,7 @@ namespace fvm
tmp<fvMatrix<Type> > ddt
(
const geometricOneField&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
@ -69,7 +69,7 @@ namespace fvm
tmp<fvMatrix<Type> > ddt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
@ -77,35 +77,35 @@ namespace fvm
tmp<fvMatrix<Type> > ddt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&,
const GeometricField<Type, fvPatchField, volMesh>&,
const word& name
);
template<class Type>
tmp<fvMatrix<Type> > ddt
(
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
template<class Type>
tmp<fvMatrix<Type> > ddt
(
const geometricOneField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
template<class Type>
tmp<fvMatrix<Type> > ddt
(
const dimensionedScalar&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
template<class Type>
tmp<fvMatrix<Type> > ddt
(
const volScalarField&,
GeometricField<Type, fvPatchField, volMesh>&
const GeometricField<Type, fvPatchField, volMesh>&
);
}

View file

@ -45,7 +45,7 @@ tmp<fvMatrix<Type> >
div
(
const surfaceScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -63,7 +63,7 @@ tmp<fvMatrix<Type> >
div
(
const tmp<surfaceScalarField>& trho,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -78,7 +78,7 @@ tmp<fvMatrix<Type> >
div
(
const surfaceScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
return fvm::div(rho, vf, "div(" + rho.name() + ',' + vf.name() + ')');
@ -90,7 +90,7 @@ tmp<fvMatrix<Type> >
div
(
const tmp<surfaceScalarField>& trho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp<fvMatrix<Type> > Div(fvm::div(trho(), vf));
@ -105,7 +105,7 @@ tmp
BlockLduSystem<vector, typename innerProduct<vector, Type>::type>
> UDiv
(
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -124,7 +124,7 @@ tmp
> UDiv
(
const surfaceScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -143,7 +143,7 @@ tmp
> UDiv
(
const tmp<surfaceScalarField>& trho,
GeometricField<Type, fvPatchField, volMesh>& vf,
const GeometricField<Type, fvPatchField, volMesh>& vf,
const word& name
)
{
@ -163,7 +163,7 @@ tmp
BlockLduSystem<vector, typename innerProduct<vector, Type>::type>
> UDiv
(
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
return fvm::UDiv
@ -181,7 +181,7 @@ tmp
> UDiv
(
const surfaceScalarField& rho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
return fvm::UDiv
@ -200,7 +200,7 @@ tmp
> UDiv
(
const tmp<surfaceScalarField>& trho,
GeometricField<Type, fvPatchField, volMesh>& vf
const GeometricField<Type, fvPatchField, volMesh>& vf
)
{
tmp

Some files were not shown because too many files have changed in this diff Show more