mirror of
https://develop.openfoam.com/Development/openfoam.git
synced 2025-11-28 03:28:01 +00:00
remove trailing space from some files
This commit is contained in:
@ -22,7 +22,7 @@
|
|||||||
volScalarField GEta = GEtaCoef/tauEta;
|
volScalarField GEta = GEtaCoef/tauEta;
|
||||||
volScalarField XiEqEta = 1.0 + XiCoef*sqrt(up/(Su + SuMin))*Reta;
|
volScalarField XiEqEta = 1.0 + XiCoef*sqrt(up/(Su + SuMin))*Reta;
|
||||||
|
|
||||||
volScalarField R =
|
volScalarField R =
|
||||||
GEta*XiEqEta/(XiEqEta - 0.999) + GIn*XiIn/(XiIn - 0.999);
|
GEta*XiEqEta/(XiEqEta - 0.999) + GIn*XiIn/(XiIn - 0.999);
|
||||||
|
|
||||||
volScalarField XiEqStar = R/(R - GEta - GIn);
|
volScalarField XiEqStar = R/(R - GEta - GIn);
|
||||||
@ -42,7 +42,7 @@
|
|||||||
volScalarField GEta = GEtaCoef/tauEta;
|
volScalarField GEta = GEtaCoef/tauEta;
|
||||||
volScalarField XiEqEta = 1.0 + XiCoef*sqrt(up/(Su + SuMin))*Reta;
|
volScalarField XiEqEta = 1.0 + XiCoef*sqrt(up/(Su + SuMin))*Reta;
|
||||||
|
|
||||||
volScalarField R =
|
volScalarField R =
|
||||||
GEta*XiEqEta/(XiEqEta - 0.999) + GIn*XiIn/(XiIn - 0.999);
|
GEta*XiEqEta/(XiEqEta - 0.999) + GIn*XiIn/(XiIn - 0.999);
|
||||||
|
|
||||||
volScalarField XiEqStar = R/(R - GEta - GIn);
|
volScalarField XiEqStar = R/(R - GEta - GIn);
|
||||||
|
|||||||
@ -91,7 +91,7 @@ bool Foam::XiModels::algebraic::read(const dictionary& XiProperties)
|
|||||||
XiModel::read(XiProperties);
|
XiModel::read(XiProperties);
|
||||||
|
|
||||||
XiModelCoeffs_.lookup("XiShapeCoef") >> XiShapeCoef;
|
XiModelCoeffs_.lookup("XiShapeCoef") >> XiShapeCoef;
|
||||||
|
|
||||||
return true;
|
return true;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -117,7 +117,7 @@ inline Foam::scalar Foam::laminarFlameSpeedModels::SCOPE::polyPhi
|
|||||||
{
|
{
|
||||||
scalar x = phi - 1.0;
|
scalar x = phi - 1.0;
|
||||||
|
|
||||||
return
|
return
|
||||||
a[0]
|
a[0]
|
||||||
*(
|
*(
|
||||||
scalar(1)
|
scalar(1)
|
||||||
|
|||||||
@ -45,7 +45,7 @@ if (adjustTimeStep)
|
|||||||
maxDeltaT
|
maxDeltaT
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "deltaT = " << runTime.deltaTValue() << endl;
|
Info<< "deltaT = " << runTime.deltaTValue() << endl;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
cd ${0%/*} || exit 1 # run from this directory
|
cd ${0%/*} || exit 1 # run from this directory
|
||||||
set -x
|
set -x
|
||||||
|
|
||||||
wmake libso BCs
|
wmake libso BCs
|
||||||
wmake
|
wmake
|
||||||
|
|
||||||
# ----------------------------------------------------------------- end-of-file
|
# ----------------------------------------------------------------- end-of-file
|
||||||
|
|||||||
@ -84,7 +84,7 @@ int main(int argc, char *argv[])
|
|||||||
(
|
(
|
||||||
fvm::ddt(rhoU)
|
fvm::ddt(rhoU)
|
||||||
+ fvm::div(phiv, rhoU)
|
+ fvm::div(phiv, rhoU)
|
||||||
==
|
==
|
||||||
- fvc::grad(p)
|
- fvc::grad(p)
|
||||||
);
|
);
|
||||||
|
|
||||||
|
|||||||
@ -2,7 +2,7 @@
|
|||||||
cd ${0%/*} || exit 1 # run from this directory
|
cd ${0%/*} || exit 1 # run from this directory
|
||||||
set -x
|
set -x
|
||||||
|
|
||||||
wmake libso BCs
|
wmake libso BCs
|
||||||
wmake
|
wmake
|
||||||
|
|
||||||
# ----------------------------------------------------------------- end-of-file
|
# ----------------------------------------------------------------- end-of-file
|
||||||
|
|||||||
@ -131,7 +131,7 @@ void inviscidWallPFvPatchScalarField::updateCoeffs()
|
|||||||
const fvPatchField<vector>& rhoUp =
|
const fvPatchField<vector>& rhoUp =
|
||||||
patch().lookupPatchField<volVectorField, vector>("rhoU");
|
patch().lookupPatchField<volVectorField, vector>("rhoU");
|
||||||
|
|
||||||
const fvsPatchField<scalar>& phip =
|
const fvsPatchField<scalar>& phip =
|
||||||
patch().lookupPatchField<surfaceScalarField, scalar>("phi");
|
patch().lookupPatchField<surfaceScalarField, scalar>("phi");
|
||||||
|
|
||||||
const fvsPatchField<scalar>& rAp =
|
const fvsPatchField<scalar>& rAp =
|
||||||
@ -147,7 +147,7 @@ void inviscidWallPFvPatchScalarField::updateCoeffs()
|
|||||||
void inviscidWallPFvPatchScalarField::write(Ostream& os) const
|
void inviscidWallPFvPatchScalarField::write(Ostream& os) const
|
||||||
{
|
{
|
||||||
fixedGradientFvPatchScalarField::write(os);
|
fixedGradientFvPatchScalarField::write(os);
|
||||||
os.writeKeyword("fluxFraction")
|
os.writeKeyword("fluxFraction")
|
||||||
<< fluxFraction_ << token::END_STATEMENT << nl;
|
<< fluxFraction_ << token::END_STATEMENT << nl;
|
||||||
writeEntry("value", os);
|
writeEntry("value", os);
|
||||||
}
|
}
|
||||||
|
|||||||
@ -145,7 +145,7 @@ void mixedRhoEFvPatchScalarField::updateCoeffs()
|
|||||||
|
|
||||||
const volScalarField& T = db().lookupObject<volScalarField>("T");
|
const volScalarField& T = db().lookupObject<volScalarField>("T");
|
||||||
const label patchi = patch().index();
|
const label patchi = patch().index();
|
||||||
fvPatchScalarField& Tp =
|
fvPatchScalarField& Tp =
|
||||||
const_cast<fvPatchScalarField&>(T.boundaryField()[patchi]);
|
const_cast<fvPatchScalarField&>(T.boundaryField()[patchi]);
|
||||||
|
|
||||||
Tp.evaluate();
|
Tp.evaluate();
|
||||||
@ -164,7 +164,7 @@ void mixedRhoEFvPatchScalarField::updateCoeffs()
|
|||||||
refGrad() =
|
refGrad() =
|
||||||
rhop*Cv.value()*Tp.snGrad()
|
rhop*Cv.value()*Tp.snGrad()
|
||||||
+ (
|
+ (
|
||||||
refValue()
|
refValue()
|
||||||
- (0.5*rhop.patchInternalField()*
|
- (0.5*rhop.patchInternalField()*
|
||||||
magSqr(rhoUp.patchInternalField()/rhop.patchInternalField()))
|
magSqr(rhoUp.patchInternalField()/rhop.patchInternalField()))
|
||||||
)*patch().deltaCoeffs();
|
)*patch().deltaCoeffs();
|
||||||
|
|||||||
@ -66,7 +66,7 @@ public:
|
|||||||
const dictionary&
|
const dictionary&
|
||||||
);
|
);
|
||||||
|
|
||||||
//- Construct by mapping given fixedRhoUFvPatchVectorField
|
//- Construct by mapping given fixedRhoUFvPatchVectorField
|
||||||
// onto a new patch
|
// onto a new patch
|
||||||
fixedRhoUFvPatchVectorField
|
fixedRhoUFvPatchVectorField
|
||||||
(
|
(
|
||||||
|
|||||||
@ -1,3 +1,3 @@
|
|||||||
electrostaticFoam.C
|
electrostaticFoam.C
|
||||||
|
|
||||||
EXE = $(FOAM_APPBIN)/electrostaticFoam
|
EXE = $(FOAM_APPBIN)/electrostaticFoam
|
||||||
|
|||||||
@ -1,3 +1,3 @@
|
|||||||
icoFoam.C
|
icoFoam.C
|
||||||
|
|
||||||
EXE = $(FOAM_APPBIN)/icoFoam
|
EXE = $(FOAM_APPBIN)/icoFoam
|
||||||
|
|||||||
@ -1,3 +1,3 @@
|
|||||||
nonNewtonianIcoFoam.C
|
nonNewtonianIcoFoam.C
|
||||||
|
|
||||||
EXE = $(FOAM_APPBIN)/nonNewtonianIcoFoam
|
EXE = $(FOAM_APPBIN)/nonNewtonianIcoFoam
|
||||||
|
|||||||
@ -1,3 +1,3 @@
|
|||||||
simpleFoam.C
|
simpleFoam.C
|
||||||
|
|
||||||
EXE = $(FOAM_APPBIN)/simpleFoam
|
EXE = $(FOAM_APPBIN)/simpleFoam
|
||||||
|
|||||||
@ -41,7 +41,7 @@ fvVectorMatrix UbEqn(Ub, Ub.dimensions()*dimVol/dimTime);
|
|||||||
- fvc::interpolate(nuEffb)
|
- fvc::interpolate(nuEffb)
|
||||||
*mesh.magSf()*fvc::snGrad(beta)/fvc::interpolate(beta + scalar(0.001));
|
*mesh.magSf()*fvc::snGrad(beta)/fvc::interpolate(beta + scalar(0.001));
|
||||||
|
|
||||||
UbEqn =
|
UbEqn =
|
||||||
(
|
(
|
||||||
(scalar(1) + Cvm*rhob*alpha/rhob)*
|
(scalar(1) + Cvm*rhob*alpha/rhob)*
|
||||||
(
|
(
|
||||||
|
|||||||
@ -36,7 +36,7 @@ scalar acousticCoNum = 0.0;
|
|||||||
|
|
||||||
if (mesh.nInternalFaces())
|
if (mesh.nInternalFaces())
|
||||||
{
|
{
|
||||||
surfaceScalarField SfUfbyDelta =
|
surfaceScalarField SfUfbyDelta =
|
||||||
mesh.surfaceInterpolation::deltaCoeffs()*mag(phiv);
|
mesh.surfaceInterpolation::deltaCoeffs()*mag(phiv);
|
||||||
|
|
||||||
CoNum = max(SfUfbyDelta/mesh.magSf())
|
CoNum = max(SfUfbyDelta/mesh.magSf())
|
||||||
|
|||||||
@ -3,12 +3,12 @@
|
|||||||
|
|
||||||
dimensionedScalar totalMass = fvc::domainIntegrate(rho);
|
dimensionedScalar totalMass = fvc::domainIntegrate(rho);
|
||||||
|
|
||||||
scalar sumLocalContErr =
|
scalar sumLocalContErr =
|
||||||
(
|
(
|
||||||
fvc::domainIntegrate(mag(rho - thermoRho))/totalMass
|
fvc::domainIntegrate(mag(rho - thermoRho))/totalMass
|
||||||
).value();
|
).value();
|
||||||
|
|
||||||
scalar globalContErr =
|
scalar globalContErr =
|
||||||
(
|
(
|
||||||
fvc::domainIntegrate(rho - thermoRho)/totalMass
|
fvc::domainIntegrate(rho - thermoRho)/totalMass
|
||||||
).value();
|
).value();
|
||||||
|
|||||||
@ -47,7 +47,7 @@ if (adjustTimeStep)
|
|||||||
maxDeltaT
|
maxDeltaT
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "deltaT = " << runTime.deltaTValue() << endl;
|
Info<< "deltaT = " << runTime.deltaTValue() << endl;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -63,7 +63,7 @@ Ostream& operator<<
|
|||||||
)
|
)
|
||||||
{
|
{
|
||||||
os << tp.theta0_ << token::SPACE
|
os << tp.theta0_ << token::SPACE
|
||||||
<< tp.uTheta_ << token::SPACE
|
<< tp.uTheta_ << token::SPACE
|
||||||
<< tp.thetaA_ << token::SPACE
|
<< tp.thetaA_ << token::SPACE
|
||||||
<< tp.thetaR_;
|
<< tp.thetaR_;
|
||||||
|
|
||||||
|
|||||||
@ -28,7 +28,7 @@ License
|
|||||||
|
|
||||||
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
|
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
|
||||||
|
|
||||||
Foam::phase::phase
|
Foam::phase::phase
|
||||||
(
|
(
|
||||||
const word& name,
|
const word& name,
|
||||||
const dictionary& phaseDict,
|
const dictionary& phaseDict,
|
||||||
|
|||||||
@ -1,5 +1,5 @@
|
|||||||
{
|
{
|
||||||
mul = muc +
|
mul = muc +
|
||||||
plasticViscosity
|
plasticViscosity
|
||||||
(
|
(
|
||||||
plasticViscosityCoeff,
|
plasticViscosityCoeff,
|
||||||
|
|||||||
@ -56,7 +56,7 @@ fvVectorMatrix UbEqn(Ub, Ub.dimensions()*dimVol/dimTime);
|
|||||||
-fvc::interpolate(nuEffb)*mesh.magSf()*fvc::snGrad(beta)
|
-fvc::interpolate(nuEffb)*mesh.magSf()*fvc::snGrad(beta)
|
||||||
/fvc::interpolate(beta + scalar(0.001));
|
/fvc::interpolate(beta + scalar(0.001));
|
||||||
|
|
||||||
UbEqn =
|
UbEqn =
|
||||||
(
|
(
|
||||||
(scalar(1) + Cvm*rhob*alpha/rhob)*
|
(scalar(1) + Cvm*rhob*alpha/rhob)*
|
||||||
(
|
(
|
||||||
|
|||||||
@ -35,9 +35,9 @@ Foam::autoPtr<Foam::conductivityModel> Foam::conductivityModel::New
|
|||||||
{
|
{
|
||||||
word conductivityModelType(dict.lookup("conductivityModel"));
|
word conductivityModelType(dict.lookup("conductivityModel"));
|
||||||
|
|
||||||
Info<< "Selecting conductivityModel "
|
Info<< "Selecting conductivityModel "
|
||||||
<< conductivityModelType << endl;
|
<< conductivityModelType << endl;
|
||||||
|
|
||||||
dictionaryConstructorTable::iterator cstrIter =
|
dictionaryConstructorTable::iterator cstrIter =
|
||||||
dictionaryConstructorTablePtr_->find(conductivityModelType);
|
dictionaryConstructorTablePtr_->find(conductivityModelType);
|
||||||
|
|
||||||
|
|||||||
@ -73,7 +73,7 @@ frictionalPressure
|
|||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
|
|
||||||
return
|
return
|
||||||
Fr*pow(max(alpha - alphaMinFriction, scalar(0)), eta)
|
Fr*pow(max(alpha - alphaMinFriction, scalar(0)), eta)
|
||||||
/pow(max(alphaMax - alpha, scalar(5.0e-2)), p);
|
/pow(max(alphaMax - alpha, scalar(5.0e-2)), p);
|
||||||
}
|
}
|
||||||
@ -104,9 +104,9 @@ Foam::tmp<Foam::volScalarField> Foam::JohnsonJacksonFrictionalStress::muf
|
|||||||
const dimensionedScalar& alphaMax,
|
const dimensionedScalar& alphaMax,
|
||||||
const volScalarField& pf,
|
const volScalarField& pf,
|
||||||
const volTensorField& D,
|
const volTensorField& D,
|
||||||
const dimensionedScalar& phi
|
const dimensionedScalar& phi
|
||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
return dimensionedScalar("0.5", dimTime, 0.5)*pf*sin(phi);
|
return dimensionedScalar("0.5", dimTime, 0.5)*pf*sin(phi);
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -35,9 +35,9 @@ Foam::autoPtr<Foam::frictionalStressModel> Foam::frictionalStressModel::New
|
|||||||
{
|
{
|
||||||
word frictionalStressModelType(dict.lookup("frictionalStressModel"));
|
word frictionalStressModelType(dict.lookup("frictionalStressModel"));
|
||||||
|
|
||||||
Info<< "Selecting frictionalStressModel "
|
Info<< "Selecting frictionalStressModel "
|
||||||
<< frictionalStressModelType << endl;
|
<< frictionalStressModelType << endl;
|
||||||
|
|
||||||
dictionaryConstructorTable::iterator cstrIter =
|
dictionaryConstructorTable::iterator cstrIter =
|
||||||
dictionaryConstructorTablePtr_->find(frictionalStressModelType);
|
dictionaryConstructorTablePtr_->find(frictionalStressModelType);
|
||||||
|
|
||||||
|
|||||||
@ -35,9 +35,9 @@ Foam::autoPtr<Foam::granularPressureModel> Foam::granularPressureModel::New
|
|||||||
{
|
{
|
||||||
word granularPressureModelType(dict.lookup("granularPressureModel"));
|
word granularPressureModelType(dict.lookup("granularPressureModel"));
|
||||||
|
|
||||||
Info<< "Selecting granularPressureModel "
|
Info<< "Selecting granularPressureModel "
|
||||||
<< granularPressureModelType << endl;
|
<< granularPressureModelType << endl;
|
||||||
|
|
||||||
dictionaryConstructorTable::iterator cstrIter =
|
dictionaryConstructorTable::iterator cstrIter =
|
||||||
dictionaryConstructorTablePtr_->find(granularPressureModelType);
|
dictionaryConstructorTablePtr_->find(granularPressureModelType);
|
||||||
|
|
||||||
|
|||||||
@ -65,7 +65,7 @@ Foam::tmp<Foam::volScalarField> Foam::CarnahanStarlingRadial::g0
|
|||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
|
|
||||||
return
|
return
|
||||||
1.0/(1.0 - alpha)
|
1.0/(1.0 - alpha)
|
||||||
+ 3.0*alpha/(2.0*sqr(1.0 - alpha))
|
+ 3.0*alpha/(2.0*sqr(1.0 - alpha))
|
||||||
+ sqr(alpha)/(2.0*pow(1.0 - alpha, 3));
|
+ sqr(alpha)/(2.0*pow(1.0 - alpha, 3));
|
||||||
@ -78,8 +78,8 @@ Foam::tmp<Foam::volScalarField> Foam::CarnahanStarlingRadial::g0prime
|
|||||||
const dimensionedScalar& alphaMax
|
const dimensionedScalar& alphaMax
|
||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
return
|
return
|
||||||
- alpha/sqr(1.0 - alpha)
|
- alpha/sqr(1.0 - alpha)
|
||||||
+ (3.0*(1.0 - alpha) + 6.0*sqr(alpha))/(2.0*(1.0 - alpha))
|
+ (3.0*(1.0 - alpha) + 6.0*sqr(alpha))/(2.0*(1.0 - alpha))
|
||||||
+ (2.0*alpha*(1.0 - alpha) + 3.0*pow(alpha, 3))
|
+ (2.0*alpha*(1.0 - alpha) + 3.0*pow(alpha, 3))
|
||||||
/(2.0*pow(1.0 - alpha, 4));
|
/(2.0*pow(1.0 - alpha, 4));
|
||||||
|
|||||||
@ -74,7 +74,7 @@ Foam::tmp<Foam::volScalarField> Foam::GidaspowRadial::g0prime
|
|||||||
const dimensionedScalar& alphaMax
|
const dimensionedScalar& alphaMax
|
||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
return
|
return
|
||||||
(-1.0/5.0)*pow(alpha/alphaMax, -2.0/3.0)
|
(-1.0/5.0)*pow(alpha/alphaMax, -2.0/3.0)
|
||||||
/(alphaMax*sqr(1.0 - pow(alpha/alphaMax, 1.0/3.0)));
|
/(alphaMax*sqr(1.0 - pow(alpha/alphaMax, 1.0/3.0)));
|
||||||
}
|
}
|
||||||
|
|||||||
@ -74,7 +74,7 @@ Foam::tmp<Foam::volScalarField> Foam::SinclairJacksonRadial::g0prime
|
|||||||
const dimensionedScalar& alphaMax
|
const dimensionedScalar& alphaMax
|
||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
return
|
return
|
||||||
(-1.0/3.0)*pow(alpha/alphaMax, -2.0/3.0)
|
(-1.0/3.0)*pow(alpha/alphaMax, -2.0/3.0)
|
||||||
/(alphaMax*sqr(1.0 - pow(alpha/alphaMax, 1.0/3.0)));
|
/(alphaMax*sqr(1.0 - pow(alpha/alphaMax, 1.0/3.0)));
|
||||||
}
|
}
|
||||||
|
|||||||
@ -35,9 +35,9 @@ Foam::autoPtr<Foam::radialModel> Foam::radialModel::New
|
|||||||
{
|
{
|
||||||
word radialModelType(dict.lookup("radialModel"));
|
word radialModelType(dict.lookup("radialModel"));
|
||||||
|
|
||||||
Info<< "Selecting radialModel "
|
Info<< "Selecting radialModel "
|
||||||
<< radialModelType << endl;
|
<< radialModelType << endl;
|
||||||
|
|
||||||
dictionaryConstructorTable::iterator cstrIter =
|
dictionaryConstructorTable::iterator cstrIter =
|
||||||
dictionaryConstructorTablePtr_->find(radialModelType);
|
dictionaryConstructorTablePtr_->find(radialModelType);
|
||||||
|
|
||||||
|
|||||||
@ -42,7 +42,7 @@
|
|||||||
|
|
||||||
phib = (fvc::interpolate(Ub) & mesh.Sf()) + fvc::ddtPhiCorr(rUbA, Ub, phib)
|
phib = (fvc::interpolate(Ub) & mesh.Sf()) + fvc::ddtPhiCorr(rUbA, Ub, phib)
|
||||||
+ phiDragb;
|
+ phiDragb;
|
||||||
|
|
||||||
phi = alphaf*phia + betaf*phib;
|
phi = alphaf*phia + betaf*phib;
|
||||||
|
|
||||||
surfaceScalarField Dp("(rho*(1|A(U)))", alphaf*rUaAf/rhoa + betaf*rUbAf/rhob);
|
surfaceScalarField Dp("(rho*(1|A(U)))", alphaf*rUaAf/rhoa + betaf*rUbAf/rhob);
|
||||||
|
|||||||
@ -177,7 +177,7 @@ void tractionDisplacementFvPatchVectorField::updateCoeffs()
|
|||||||
gradient() =
|
gradient() =
|
||||||
(
|
(
|
||||||
(traction_ + pressure_*n)/rho.value()
|
(traction_ + pressure_*n)/rho.value()
|
||||||
+ twoMuLambda*fvPatchField<vector>::snGrad() - (n & sigmaD)
|
+ twoMuLambda*fvPatchField<vector>::snGrad() - (n & sigmaD)
|
||||||
)/twoMuLambda;
|
)/twoMuLambda;
|
||||||
|
|
||||||
Switch thermalStress(thermalProperties.lookup("thermalStress"));
|
Switch thermalStress(thermalProperties.lookup("thermalStress"));
|
||||||
@ -187,7 +187,7 @@ void tractionDisplacementFvPatchVectorField::updateCoeffs()
|
|||||||
dimensionedScalar alpha(thermalProperties.lookup("alpha"));
|
dimensionedScalar alpha(thermalProperties.lookup("alpha"));
|
||||||
dimensionedScalar threeKalpha = threeK*alpha;
|
dimensionedScalar threeKalpha = threeK*alpha;
|
||||||
|
|
||||||
const fvPatchField<scalar>& T =
|
const fvPatchField<scalar>& T =
|
||||||
patch().lookupPatchField<volScalarField, scalar>("T");
|
patch().lookupPatchField<volScalarField, scalar>("T");
|
||||||
|
|
||||||
gradient() += n*threeKalpha.value()*T/twoMuLambda;
|
gradient() += n*threeKalpha.value()*T/twoMuLambda;
|
||||||
|
|||||||
@ -72,7 +72,7 @@ int main(int argc, char *argv[])
|
|||||||
{
|
{
|
||||||
volTensorField gradDcorr = fvc::grad(Dcorr);
|
volTensorField gradDcorr = fvc::grad(Dcorr);
|
||||||
|
|
||||||
sigmaExp =
|
sigmaExp =
|
||||||
(lambda - mu)*gradDcorr + mu*gradDcorr.T()
|
(lambda - mu)*gradDcorr + mu*gradDcorr.T()
|
||||||
+ (lambda*I)*tr(gradDcorr);
|
+ (lambda*I)*tr(gradDcorr);
|
||||||
|
|
||||||
|
|||||||
@ -171,7 +171,7 @@ void tractionDisplacementCorrectionFvPatchVectorField::updateCoeffs()
|
|||||||
const fvPatchField<symmTensor>& sigmaD =
|
const fvPatchField<symmTensor>& sigmaD =
|
||||||
patch().lookupPatchField<volSymmTensorField, symmTensor>("sigmaD");
|
patch().lookupPatchField<volSymmTensorField, symmTensor>("sigmaD");
|
||||||
|
|
||||||
const fvPatchField<tensor>& sigmaExp =
|
const fvPatchField<tensor>& sigmaExp =
|
||||||
patch().lookupPatchField<volTensorField, tensor>("sigmaExp");
|
patch().lookupPatchField<volTensorField, tensor>("sigmaExp");
|
||||||
|
|
||||||
gradient() =
|
gradient() =
|
||||||
|
|||||||
@ -67,7 +67,7 @@ class edgeStats
|
|||||||
|
|
||||||
//- If 2d get component of normal dir.
|
//- If 2d get component of normal dir.
|
||||||
direction getNormalDir(const twoDPointCorrector*) const;
|
direction getNormalDir(const twoDPointCorrector*) const;
|
||||||
|
|
||||||
|
|
||||||
//- Disallow default bitwise copy construct
|
//- Disallow default bitwise copy construct
|
||||||
edgeStats(const edgeStats&);
|
edgeStats(const edgeStats&);
|
||||||
|
|||||||
@ -2,35 +2,35 @@ Notes for fluentMeshToFoam with zone preservation
|
|||||||
#################################################
|
#################################################
|
||||||
|
|
||||||
1. New option added:
|
1. New option added:
|
||||||
- writeSets:
|
- writeSets:
|
||||||
Writes all Fluent boundaries faceSets preserving Fluent names
|
Writes all Fluent boundaries faceSets preserving Fluent names
|
||||||
Writes all Fluent regions to cellSets preserving Fluent names
|
Writes all Fluent regions to cellSets preserving Fluent names
|
||||||
lines: 1375 - 1393 & 1673 - 1741
|
lines: 1375 - 1393 & 1673 - 1741
|
||||||
sets are useful for post-processing using foamToVTK with the "-faceSet
|
sets are useful for post-processing using foamToVTK with the "-faceSet
|
||||||
<name>" and "-cellSet <name>" options.
|
<name>" and "-cellSet <name>" options.
|
||||||
|
|
||||||
- writeZones:
|
- writeZones:
|
||||||
Writes all regions to cellZones preserving Fluent names
|
Writes all regions to cellZones preserving Fluent names
|
||||||
Writes all region internal face to faceZones preserving Fluent names
|
Writes all region internal face to faceZones preserving Fluent names
|
||||||
lines: 1545 - 1667
|
lines: 1545 - 1667
|
||||||
Zones are usefull for porous media and MRF calculations
|
Zones are usefull for porous media and MRF calculations
|
||||||
|
|
||||||
2. Zone Access
|
2. Zone Access
|
||||||
- Zones are simple lists of label lists that can be accessed from polyMesh
|
- Zones are simple lists of label lists that can be accessed from polyMesh
|
||||||
with the cellZones(), faceZones() and pointZones() member functions
|
with the cellZones(), faceZones() and pointZones() member functions
|
||||||
|
|
||||||
- Example (Members from polyMesh.H and ZoneMesh.H):
|
- Example (Members from polyMesh.H and ZoneMesh.H):
|
||||||
label thisCellZoneID = mesh.cellZones().findZoneID("thisZoneName");
|
label thisCellZoneID = mesh.cellZones().findZoneID("thisZoneName");
|
||||||
const labelList& thisCellZone = mesh.cellZones()[thisCellZoneID];
|
const labelList& thisCellZone = mesh.cellZones()[thisCellZoneID];
|
||||||
|
|
||||||
- Zone integrity is preserved during mesh modification and decompomposition.
|
- Zone integrity is preserved during mesh modification and decompomposition.
|
||||||
|
|
||||||
- Once created via addZones, zones allow modification through non-const
|
- Once created via addZones, zones allow modification through non-const
|
||||||
access
|
access
|
||||||
|
|
||||||
3. Fluent boundary types.
|
3. Fluent boundary types.
|
||||||
- All internal and baffle elements are ignored during conversion
|
- All internal and baffle elements are ignored during conversion
|
||||||
|
|
||||||
- Boundary faces labelled as internal (i.e. interior, interface, internal,
|
- Boundary faces labelled as internal (i.e. interior, interface, internal,
|
||||||
solid, fan, radiator, porous-jump) but that are in fact external boundaries
|
solid, fan, radiator, porous-jump) but that are in fact external boundaries
|
||||||
will be added to a default wall boundary.
|
will be added to a default wall boundary.
|
||||||
|
|||||||
@ -4,4 +4,4 @@ EXE_INC = \
|
|||||||
|
|
||||||
EXE_LIBS = \
|
EXE_LIBS = \
|
||||||
-ldynamicMesh \
|
-ldynamicMesh \
|
||||||
-lmeshTools
|
-lmeshTools
|
||||||
|
|||||||
@ -188,7 +188,7 @@ void sammMesh::readBoundary()
|
|||||||
boundary_[patchLabel][nPatchFaces[patchLabel]]
|
boundary_[patchLabel][nPatchFaces[patchLabel]]
|
||||||
= face(pointLabels);
|
= face(pointLabels);
|
||||||
}
|
}
|
||||||
|
|
||||||
// increment counter of faces in current patch
|
// increment counter of faces in current patch
|
||||||
nPatchFaces[patchLabel]++;
|
nPatchFaces[patchLabel]++;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -186,7 +186,7 @@ void starMesh::readBoundary()
|
|||||||
boundary_[patchLabel][nPatchFaces[patchLabel]]
|
boundary_[patchLabel][nPatchFaces[patchLabel]]
|
||||||
= face(pointLabels);
|
= face(pointLabels);
|
||||||
}
|
}
|
||||||
|
|
||||||
// increment counter of faces in current patch
|
// increment counter of faces in current patch
|
||||||
nPatchFaces[patchLabel]++;
|
nPatchFaces[patchLabel]++;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -95,7 +95,7 @@ void starMesh::readPoints(const scalar scaleFactor)
|
|||||||
pointLabel = readVtxLabel(pointsFile);
|
pointLabel = readVtxLabel(pointsFile);
|
||||||
|
|
||||||
if (!pointsFile) break;
|
if (!pointsFile) break;
|
||||||
|
|
||||||
maxLabel = max(maxLabel, pointLabel);
|
maxLabel = max(maxLabel, pointLabel);
|
||||||
|
|
||||||
x = readVtxCmpt(pointsFile);
|
x = readVtxCmpt(pointsFile);
|
||||||
|
|||||||
@ -2,4 +2,4 @@ EXE_INC = \
|
|||||||
-I$(LIB_SRC)/meshTools/lnInclude
|
-I$(LIB_SRC)/meshTools/lnInclude
|
||||||
|
|
||||||
EXE_LIBS = \
|
EXE_LIBS = \
|
||||||
-lmeshTools
|
-lmeshTools
|
||||||
|
|||||||
@ -95,7 +95,7 @@ Foam::Xfer<Foam::faceList> Foam::extrudedMesh::extrudedFaces
|
|||||||
|
|
||||||
const label nLayers = model.nLayers();
|
const label nLayers = model.nLayers();
|
||||||
|
|
||||||
label nFaces =
|
label nFaces =
|
||||||
(nLayers + 1)*surfaceFaces.size() + nLayers*surfaceEdges.size();
|
(nLayers + 1)*surfaceFaces.size() + nLayers*surfaceEdges.size();
|
||||||
|
|
||||||
faceList eFaces(nFaces);
|
faceList eFaces(nFaces);
|
||||||
|
|||||||
@ -192,7 +192,7 @@ int main(int argc, char *argv[])
|
|||||||
autoRefineDriver::debug = debug;
|
autoRefineDriver::debug = debug;
|
||||||
autoSnapDriver::debug = debug;
|
autoSnapDriver::debug = debug;
|
||||||
autoLayerDriver::debug = debug;
|
autoLayerDriver::debug = debug;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
// Read geometry
|
// Read geometry
|
||||||
|
|||||||
@ -129,7 +129,7 @@ void Foam::printMeshStats(const polyMesh& mesh, const bool allTopology)
|
|||||||
}
|
}
|
||||||
|
|
||||||
reduce(nHex,sumOp<label>());
|
reduce(nHex,sumOp<label>());
|
||||||
reduce(nPrism,sumOp<label>());
|
reduce(nPrism,sumOp<label>());
|
||||||
reduce(nWedge,sumOp<label>());
|
reduce(nWedge,sumOp<label>());
|
||||||
reduce(nPyr,sumOp<label>());
|
reduce(nPyr,sumOp<label>());
|
||||||
reduce(nTetWedge,sumOp<label>());
|
reduce(nTetWedge,sumOp<label>());
|
||||||
|
|||||||
@ -26,7 +26,7 @@ Application
|
|||||||
moveEngineMesh
|
moveEngineMesh
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Solver for moving meshes for engine calculations.
|
Solver for moving meshes for engine calculations.
|
||||||
|
|
||||||
\*---------------------------------------------------------------------------*/
|
\*---------------------------------------------------------------------------*/
|
||||||
|
|
||||||
@ -54,7 +54,7 @@ int main(int argc, char *argv[])
|
|||||||
mesh.move();
|
mesh.move();
|
||||||
|
|
||||||
runTime.write();
|
runTime.write();
|
||||||
|
|
||||||
Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
|
Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
|
||||||
<< " ClockTime = " << runTime.elapsedClockTime() << " s"
|
<< " ClockTime = " << runTime.elapsedClockTime() << " s"
|
||||||
<< nl << endl;
|
<< nl << endl;
|
||||||
|
|||||||
@ -1,4 +1,4 @@
|
|||||||
/*
|
/*
|
||||||
EXE_INC = \
|
EXE_INC = \
|
||||||
-I$(LIB_SRC)/triSurface/lnInclude
|
-I$(LIB_SRC)/triSurface/lnInclude
|
||||||
|
|
||||||
|
|||||||
@ -67,7 +67,7 @@ void writePatch
|
|||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write topology
|
// Write topology
|
||||||
//
|
//
|
||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
|
|
||||||
|
|
||||||
@ -108,7 +108,7 @@ void writePatch
|
|||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write data
|
// Write data
|
||||||
//
|
//
|
||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
|
|
||||||
// Write faceID
|
// Write faceID
|
||||||
|
|||||||
@ -64,7 +64,7 @@ void writePointSet
|
|||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write topology
|
// Write topology
|
||||||
//
|
//
|
||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
|
|
||||||
|
|
||||||
@ -86,7 +86,7 @@ void writePointSet
|
|||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write data
|
// Write data
|
||||||
//
|
//
|
||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
|
|
||||||
// Write pointID
|
// Write pointID
|
||||||
|
|||||||
@ -1,6 +1,6 @@
|
|||||||
EXE_INC = \
|
EXE_INC = \
|
||||||
-I$(LIB_SRC)/dynamicMesh/lnInclude \
|
-I$(LIB_SRC)/dynamicMesh/lnInclude \
|
||||||
-I$(LIB_SRC)/meshTools/lnInclude
|
-I$(LIB_SRC)/meshTools/lnInclude
|
||||||
|
|
||||||
EXE_LIBS = \
|
EXE_LIBS = \
|
||||||
-ldynamicMesh \
|
-ldynamicMesh \
|
||||||
|
|||||||
@ -376,7 +376,7 @@ void Foam::regionSide::walkAllPointConnectedFaces
|
|||||||
// Get the face 'perpendicular' to faceI on region.
|
// Get the face 'perpendicular' to faceI on region.
|
||||||
label otherFaceI = otherFace(mesh, cellI, faceI, edgeI);
|
label otherFaceI = otherFace(mesh, cellI, faceI, edgeI);
|
||||||
|
|
||||||
// Edge
|
// Edge
|
||||||
const edge& e = mesh.edges()[edgeI];
|
const edge& e = mesh.edges()[edgeI];
|
||||||
|
|
||||||
if (!visitedPoint.found(e.start()))
|
if (!visitedPoint.found(e.start()))
|
||||||
|
|||||||
@ -26,7 +26,7 @@ Class
|
|||||||
Foam::regionSide
|
Foam::regionSide
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Determines the 'side' for every face and connected to a
|
Determines the 'side' for every face and connected to a
|
||||||
singly-connected (through edges) region of faces. Gets set of faces and
|
singly-connected (through edges) region of faces. Gets set of faces and
|
||||||
a list of mesh edges ('fenceEdges') which should not be crossed.
|
a list of mesh edges ('fenceEdges') which should not be crossed.
|
||||||
Used in splitting a mesh region.
|
Used in splitting a mesh region.
|
||||||
|
|||||||
@ -26,7 +26,7 @@ Application
|
|||||||
zipUpMesh
|
zipUpMesh
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Reads in a mesh with hanging vertices and zips up the cells to guarantee
|
Reads in a mesh with hanging vertices and zips up the cells to guarantee
|
||||||
that all polyhedral cells of valid shape are closed.
|
that all polyhedral cells of valid shape are closed.
|
||||||
|
|
||||||
Meshes with hanging vertices may occur as a result of split
|
Meshes with hanging vertices may occur as a result of split
|
||||||
|
|||||||
@ -82,7 +82,7 @@ manualCoeffs
|
|||||||
//// Is the case distributed
|
//// Is the case distributed
|
||||||
//distributed yes;
|
//distributed yes;
|
||||||
//// Per slave (so nProcs-1 entries) the directory above the case.
|
//// Per slave (so nProcs-1 entries) the directory above the case.
|
||||||
//roots
|
//roots
|
||||||
//(
|
//(
|
||||||
// "/tmp"
|
// "/tmp"
|
||||||
// "/tmp"
|
// "/tmp"
|
||||||
|
|||||||
@ -200,10 +200,10 @@ private:
|
|||||||
//- List of patch field decomposers
|
//- List of patch field decomposers
|
||||||
List<patchFieldDecomposer*> patchFieldDecomposerPtrs_;
|
List<patchFieldDecomposer*> patchFieldDecomposerPtrs_;
|
||||||
|
|
||||||
List<processorVolPatchFieldDecomposer*>
|
List<processorVolPatchFieldDecomposer*>
|
||||||
processorVolPatchFieldDecomposerPtrs_;
|
processorVolPatchFieldDecomposerPtrs_;
|
||||||
|
|
||||||
List<processorSurfacePatchFieldDecomposer*>
|
List<processorSurfacePatchFieldDecomposer*>
|
||||||
processorSurfacePatchFieldDecomposerPtrs_;
|
processorSurfacePatchFieldDecomposerPtrs_;
|
||||||
|
|
||||||
|
|
||||||
|
|||||||
@ -56,7 +56,7 @@ enum {
|
|||||||
XF_RF_DATA_PREMIXC_RATE=44,
|
XF_RF_DATA_PREMIXC_RATE=44,
|
||||||
XF_RF_DATA_POLLUT2=45,
|
XF_RF_DATA_POLLUT2=45,
|
||||||
XF_RF_DATA_POLLUT3=46,
|
XF_RF_DATA_POLLUT3=46,
|
||||||
|
|
||||||
XF_RF_DATA_MASS_FLUX_M1=47,
|
XF_RF_DATA_MASS_FLUX_M1=47,
|
||||||
XF_RF_DATA_MASS_FLUX_M2=48,
|
XF_RF_DATA_MASS_FLUX_M2=48,
|
||||||
XF_RF_DATA_GRID_FLUX=49,
|
XF_RF_DATA_GRID_FLUX=49,
|
||||||
@ -78,7 +78,7 @@ enum {
|
|||||||
XF_RF_DATA_SLIP_W=62,
|
XF_RF_DATA_SLIP_W=62,
|
||||||
|
|
||||||
XF_RF_DATA_SDR=63, /* omega in the k-w model */
|
XF_RF_DATA_SDR=63, /* omega in the k-w model */
|
||||||
XF_RF_DATA_SDR_M1=64,
|
XF_RF_DATA_SDR_M1=64,
|
||||||
XF_RF_DATA_SDR_M2=65,
|
XF_RF_DATA_SDR_M2=65,
|
||||||
|
|
||||||
XF_RF_DATA_POLLUT4=66,
|
XF_RF_DATA_POLLUT4=66,
|
||||||
@ -86,7 +86,7 @@ enum {
|
|||||||
XF_RF_DATA_GRANULAR_TEMPERATURE_M1 = 68,
|
XF_RF_DATA_GRANULAR_TEMPERATURE_M1 = 68,
|
||||||
XF_RF_DATA_GRANULAR_TEMPERATURE_M2 = 69,
|
XF_RF_DATA_GRANULAR_TEMPERATURE_M2 = 69,
|
||||||
|
|
||||||
XF_RF_DATA_VFLUX=70,
|
XF_RF_DATA_VFLUX=70,
|
||||||
|
|
||||||
XF_RF_DATA_VFLUX_M1=80,
|
XF_RF_DATA_VFLUX_M1=80,
|
||||||
|
|
||||||
@ -118,7 +118,7 @@ enum {
|
|||||||
XF_RF_DATA_X_VELOCITY_M1=115,
|
XF_RF_DATA_X_VELOCITY_M1=115,
|
||||||
XF_RF_DATA_Y_VELOCITY_M1=116,
|
XF_RF_DATA_Y_VELOCITY_M1=116,
|
||||||
XF_RF_DATA_Z_VELOCITY_M1=117,
|
XF_RF_DATA_Z_VELOCITY_M1=117,
|
||||||
|
|
||||||
XF_RF_DATA_PHASE_MASS=118, /* cavitation mass source */
|
XF_RF_DATA_PHASE_MASS=118, /* cavitation mass source */
|
||||||
XF_RF_DATA_TEMPERATURE_M1=0, /* never stored but symbol is required
|
XF_RF_DATA_TEMPERATURE_M1=0, /* never stored but symbol is required
|
||||||
*/
|
*/
|
||||||
@ -139,7 +139,7 @@ enum {
|
|||||||
XF_RF_DATA_RUV=131, /* V5 reynolds stress model */
|
XF_RF_DATA_RUV=131, /* V5 reynolds stress model */
|
||||||
XF_RF_DATA_RVW=132, /* V5 reynolds stress model */
|
XF_RF_DATA_RVW=132, /* V5 reynolds stress model */
|
||||||
XF_RF_DATA_RUW=133, /* V5 reynolds stress model */
|
XF_RF_DATA_RUW=133, /* V5 reynolds stress model */
|
||||||
|
|
||||||
XF_RF_DATA_DPMS_EROSION=134,
|
XF_RF_DATA_DPMS_EROSION=134,
|
||||||
XF_RF_DATA_DPMS_ACCRETION=135,
|
XF_RF_DATA_DPMS_ACCRETION=135,
|
||||||
|
|
||||||
@ -162,17 +162,17 @@ enum {
|
|||||||
XF_RF_DATA_PREMIXC_M2=149,
|
XF_RF_DATA_PREMIXC_M2=149,
|
||||||
|
|
||||||
/*vof 1,2,3,4 kept for v5 compatibility */
|
/*vof 1,2,3,4 kept for v5 compatibility */
|
||||||
XF_RF_DATA_VOF = 150,
|
XF_RF_DATA_VOF = 150,
|
||||||
XF_RF_DATA_VOF_1 = 151,
|
XF_RF_DATA_VOF_1 = 151,
|
||||||
XF_RF_DATA_VOF_2 = 152,
|
XF_RF_DATA_VOF_2 = 152,
|
||||||
XF_RF_DATA_VOF_3 = 153,
|
XF_RF_DATA_VOF_3 = 153,
|
||||||
XF_RF_DATA_VOF_4 = 154,
|
XF_RF_DATA_VOF_4 = 154,
|
||||||
|
|
||||||
XF_RF_DATA_VOF_M1 = 160 ,
|
XF_RF_DATA_VOF_M1 = 160 ,
|
||||||
XF_RF_DATA_VOF_1_M1 = 161 ,
|
XF_RF_DATA_VOF_1_M1 = 161 ,
|
||||||
XF_RF_DATA_VOF_2_M1 = 162 ,
|
XF_RF_DATA_VOF_2_M1 = 162 ,
|
||||||
XF_RF_DATA_VOF_3_M1 = 163 ,
|
XF_RF_DATA_VOF_3_M1 = 163 ,
|
||||||
XF_RF_DATA_VOF_4_M1 = 164 ,
|
XF_RF_DATA_VOF_4_M1 = 164 ,
|
||||||
|
|
||||||
XF_RF_DATA_VOF_M2 = 170 ,
|
XF_RF_DATA_VOF_M2 = 170 ,
|
||||||
XF_RF_DATA_VOF_1_M2 = 171 ,
|
XF_RF_DATA_VOF_1_M2 = 171 ,
|
||||||
@ -194,7 +194,7 @@ coefficient for particles */
|
|||||||
XF_RF_DATA_NRBC_DC=194, /* change in char. var for
|
XF_RF_DATA_NRBC_DC=194, /* change in char. var for
|
||||||
nrbc*/
|
nrbc*/
|
||||||
|
|
||||||
|
|
||||||
EXPAND_50_EQUAL(XF_RF_DATA_Y_, 200), /* species */
|
EXPAND_50_EQUAL(XF_RF_DATA_Y_, 200), /* species */
|
||||||
EXPAND_50(XF_RF_DATA_Y_,_M1=, 250), /* species at fist time
|
EXPAND_50(XF_RF_DATA_Y_,_M1=, 250), /* species at fist time
|
||||||
level */
|
level */
|
||||||
@ -219,21 +219,21 @@ level */
|
|||||||
XF_RF_DATA_VOF_MEAN=410,
|
XF_RF_DATA_VOF_MEAN=410,
|
||||||
XF_RF_DATA_VOF_RMS=411,
|
XF_RF_DATA_VOF_RMS=411,
|
||||||
EXPAND_50_EQUAL(XF_RF_DATA_DPMS_Y_,450),
|
EXPAND_50_EQUAL(XF_RF_DATA_DPMS_Y_,450),
|
||||||
|
|
||||||
/* Don't add section ids here unless you need a large contiguous
|
/* Don't add section ids here unless you need a large contiguous
|
||||||
chunk.
|
chunk.
|
||||||
* Use id's 40-100 first! */
|
* Use id's 40-100 first! */
|
||||||
XF_RF_DATA_NUT=500,
|
XF_RF_DATA_NUT=500,
|
||||||
XF_RF_DATA_NUT_M1=501,
|
XF_RF_DATA_NUT_M1=501,
|
||||||
XF_RF_DATA_NUT_M2=502,
|
XF_RF_DATA_NUT_M2=502,
|
||||||
|
|
||||||
XF_RF_DATA_RUU_M1=503,
|
XF_RF_DATA_RUU_M1=503,
|
||||||
XF_RF_DATA_RVV_M1=504,
|
XF_RF_DATA_RVV_M1=504,
|
||||||
XF_RF_DATA_RWW_M1=505,
|
XF_RF_DATA_RWW_M1=505,
|
||||||
XF_RF_DATA_RUV_M1=506,
|
XF_RF_DATA_RUV_M1=506,
|
||||||
XF_RF_DATA_RVW_M1=507,
|
XF_RF_DATA_RVW_M1=507,
|
||||||
XF_RF_DATA_RUW_M1=508,
|
XF_RF_DATA_RUW_M1=508,
|
||||||
|
|
||||||
XF_RF_DATA_RUU_M2=509,
|
XF_RF_DATA_RUU_M2=509,
|
||||||
XF_RF_DATA_RVV_M2=510,
|
XF_RF_DATA_RVV_M2=510,
|
||||||
XF_RF_DATA_RWW_M2=511,
|
XF_RF_DATA_RWW_M2=511,
|
||||||
@ -246,7 +246,7 @@ chunk.
|
|||||||
|
|
||||||
XF_RF_DATA_DENSITY_M1=517,
|
XF_RF_DATA_DENSITY_M1=517,
|
||||||
XF_RF_DATA_DENSITY_M2=518,
|
XF_RF_DATA_DENSITY_M2=518,
|
||||||
|
|
||||||
XF_RF_DATA_DPMS_PDF_1=519,
|
XF_RF_DATA_DPMS_PDF_1=519,
|
||||||
XF_RF_DATA_DPMS_PDF_2=520,
|
XF_RF_DATA_DPMS_PDF_2=520,
|
||||||
|
|
||||||
|
|||||||
@ -42,7 +42,7 @@ labelList calcFaceAddressing
|
|||||||
const label cellI
|
const label cellI
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
// return value.
|
// return value.
|
||||||
labelList shapeToMesh(shape.nFaces(), -1);
|
labelList shapeToMesh(shape.nFaces(), -1);
|
||||||
|
|
||||||
const faceList modelFaces(shape.faces());
|
const faceList modelFaces(shape.faces());
|
||||||
|
|||||||
@ -10,9 +10,9 @@ EXE_INC = \
|
|||||||
-I$(LIB_SRC)/browser/lnInclude \
|
-I$(LIB_SRC)/browser/lnInclude \
|
||||||
-I$(LIB_SRC)/foam/lnInclude \
|
-I$(LIB_SRC)/foam/lnInclude \
|
||||||
-I$(LIB_SRC)/lagrangian/basic/lnInclude \
|
-I$(LIB_SRC)/lagrangian/basic/lnInclude \
|
||||||
-I$(LIB_SRC)/lagrangian/dieselSpray/lnInclude
|
-I$(LIB_SRC)/lagrangian/dieselSpray/lnInclude
|
||||||
|
|
||||||
EXE_LIBS = \
|
EXE_LIBS = \
|
||||||
-lfiniteVolume \
|
-lfiniteVolume \
|
||||||
-lgenericPatchFields \
|
-lgenericPatchFields \
|
||||||
-llagrangian
|
-llagrangian
|
||||||
|
|||||||
@ -28,7 +28,7 @@ for (label indx=0;indx<cells.size();indx++)
|
|||||||
gmvFile << "hex " << 8 << " ";
|
gmvFile << "hex " << 8 << " ";
|
||||||
for (label ip=0; ip<nNodes; ip++)
|
for (label ip=0; ip<nNodes; ip++)
|
||||||
{
|
{
|
||||||
gmvFile << cells[indx][ip] + 1 << " ";
|
gmvFile << cells[indx][ip] + 1 << " ";
|
||||||
}
|
}
|
||||||
gmvFile << nl;
|
gmvFile << nl;
|
||||||
}
|
}
|
||||||
@ -37,7 +37,7 @@ for (label indx=0;indx<cells.size();indx++)
|
|||||||
gmvFile << "tet " << 4 << " ";
|
gmvFile << "tet " << 4 << " ";
|
||||||
for (label ip=0; ip<nNodes; ip++)
|
for (label ip=0; ip<nNodes; ip++)
|
||||||
{
|
{
|
||||||
gmvFile << cells[indx][ip] + 1 << " ";
|
gmvFile << cells[indx][ip] + 1 << " ";
|
||||||
}
|
}
|
||||||
gmvFile << nl;
|
gmvFile << nl;
|
||||||
}
|
}
|
||||||
@ -46,7 +46,7 @@ for (label indx=0;indx<cells.size();indx++)
|
|||||||
gmvFile << "prism " << 6 << " ";
|
gmvFile << "prism " << 6 << " ";
|
||||||
for (label ip=0; ip<nNodes; ip++)
|
for (label ip=0; ip<nNodes; ip++)
|
||||||
{
|
{
|
||||||
gmvFile << cells[indx][ip] + 1 << " ";
|
gmvFile << cells[indx][ip] + 1 << " ";
|
||||||
}
|
}
|
||||||
gmvFile << nl;
|
gmvFile << nl;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -28,11 +28,11 @@ word format
|
|||||||
|
|
||||||
if ( (format != "ascii") && (format != "ieeei4r8") )
|
if ( (format != "ascii") && (format != "ieeei4r8") )
|
||||||
{
|
{
|
||||||
FatalError << "format type: " << format << " unknown."
|
FatalError << "format type: " << format << " unknown."
|
||||||
<< " Valid options are: ascii ieeei4r8"
|
<< " Valid options are: ascii ieeei4r8"
|
||||||
<< abort(FatalError);
|
<< abort(FatalError);
|
||||||
|
|
||||||
}
|
}
|
||||||
word cells
|
word cells
|
||||||
(
|
(
|
||||||
conversionProperties.lookup("cells")
|
conversionProperties.lookup("cells")
|
||||||
|
|||||||
@ -674,7 +674,7 @@ int main(int argc, char *argv[])
|
|||||||
+ timeDesc
|
+ timeDesc
|
||||||
+ ".plt"
|
+ ".plt"
|
||||||
);
|
);
|
||||||
|
|
||||||
tecplotWriter writer(runTime);
|
tecplotWriter writer(runTime);
|
||||||
|
|
||||||
writer.writeInit
|
writer.writeInit
|
||||||
|
|||||||
@ -26,7 +26,7 @@ InClass
|
|||||||
Foam::readFields
|
Foam::readFields
|
||||||
|
|
||||||
Description
|
Description
|
||||||
|
|
||||||
SourceFiles
|
SourceFiles
|
||||||
readFields.C
|
readFields.C
|
||||||
|
|
||||||
|
|||||||
@ -64,7 +64,7 @@ Pout<< endl
|
|||||||
const_cast<char*>(varNames.c_str()), /* Variable List */
|
const_cast<char*>(varNames.c_str()), /* Variable List */
|
||||||
const_cast<char*>(fName.c_str()), /* File Name */
|
const_cast<char*>(fName.c_str()), /* File Name */
|
||||||
const_cast<char*>(runTime_.path().c_str()), /* Scratch Directory */
|
const_cast<char*>(runTime_.path().c_str()), /* Scratch Directory */
|
||||||
&tecplotFileType,
|
&tecplotFileType,
|
||||||
&Debug,
|
&Debug,
|
||||||
&IsDouble
|
&IsDouble
|
||||||
)
|
)
|
||||||
@ -99,11 +99,11 @@ void Foam::tecplotWriter::writePolyhedralZone
|
|||||||
|
|
||||||
INTEGER4 IsBlock = 1; /* block format */
|
INTEGER4 IsBlock = 1; /* block format */
|
||||||
|
|
||||||
INTEGER4 NFConns = 0; /* not used for FEPolyhedron
|
INTEGER4 NFConns = 0; /* not used for FEPolyhedron
|
||||||
* zones
|
* zones
|
||||||
*/
|
*/
|
||||||
INTEGER4 FNMode = 0; /* not used for FEPolyhedron
|
INTEGER4 FNMode = 0; /* not used for FEPolyhedron
|
||||||
* zones
|
* zones
|
||||||
*/
|
*/
|
||||||
Pout<< "zoneName:" << zoneName
|
Pout<< "zoneName:" << zoneName
|
||||||
//<< " varLocArray:" << varLocArray
|
//<< " varLocArray:" << varLocArray
|
||||||
@ -112,9 +112,9 @@ Pout<< "zoneName:" << zoneName
|
|||||||
|
|
||||||
|
|
||||||
|
|
||||||
INTEGER4 *PassiveVarArray = NULL;
|
INTEGER4 *PassiveVarArray = NULL;
|
||||||
INTEGER4 *VarShareArray = NULL;
|
INTEGER4 *VarShareArray = NULL;
|
||||||
INTEGER4 ShrConn = 0;
|
INTEGER4 ShrConn = 0;
|
||||||
|
|
||||||
INTEGER4 NumBConns = 0; /* No Boundary Connections */
|
INTEGER4 NumBConns = 0; /* No Boundary Connections */
|
||||||
INTEGER4 NumBItems = 0; /* No Boundary Items */
|
INTEGER4 NumBItems = 0; /* No Boundary Items */
|
||||||
@ -126,16 +126,16 @@ Pout<< "zoneName:" << zoneName
|
|||||||
!TECZNE112
|
!TECZNE112
|
||||||
(
|
(
|
||||||
const_cast<char*>(zoneName.c_str()),
|
const_cast<char*>(zoneName.c_str()),
|
||||||
&ZoneType,
|
&ZoneType,
|
||||||
&NumNodes,
|
&NumNodes,
|
||||||
&NumElems,
|
&NumElems,
|
||||||
&NumFaces,
|
&NumFaces,
|
||||||
&ICellMax,
|
&ICellMax,
|
||||||
&JCellMax,
|
&JCellMax,
|
||||||
&KCellMax,
|
&KCellMax,
|
||||||
&SolTime,
|
&SolTime,
|
||||||
&strandID,
|
&strandID,
|
||||||
&ParentZone,
|
&ParentZone,
|
||||||
&IsBlock,
|
&IsBlock,
|
||||||
&NFConns,
|
&NFConns,
|
||||||
&FNMode,
|
&FNMode,
|
||||||
@ -177,11 +177,11 @@ void Foam::tecplotWriter::writePolygonalZone
|
|||||||
|
|
||||||
INTEGER4 IsBlock = 1; /* block format */
|
INTEGER4 IsBlock = 1; /* block format */
|
||||||
|
|
||||||
INTEGER4 NFConns = 0; /* not used for FEPolyhedron
|
INTEGER4 NFConns = 0; /* not used for FEPolyhedron
|
||||||
* zones
|
* zones
|
||||||
*/
|
*/
|
||||||
INTEGER4 FNMode = 0; /* not used for FEPolyhedron
|
INTEGER4 FNMode = 0; /* not used for FEPolyhedron
|
||||||
* zones
|
* zones
|
||||||
*/
|
*/
|
||||||
INTEGER4 NumFaceNodes = 2*pp.nEdges();
|
INTEGER4 NumFaceNodes = 2*pp.nEdges();
|
||||||
|
|
||||||
@ -192,9 +192,9 @@ Pout<< "zoneName:" << zoneName
|
|||||||
<< endl;
|
<< endl;
|
||||||
|
|
||||||
|
|
||||||
INTEGER4 *PassiveVarArray = NULL;
|
INTEGER4 *PassiveVarArray = NULL;
|
||||||
INTEGER4 *VarShareArray = NULL;
|
INTEGER4 *VarShareArray = NULL;
|
||||||
INTEGER4 ShrConn = 0;
|
INTEGER4 ShrConn = 0;
|
||||||
|
|
||||||
INTEGER4 NumBConns = 0; /* No Boundary Connections */
|
INTEGER4 NumBConns = 0; /* No Boundary Connections */
|
||||||
INTEGER4 NumBItems = 0; /* No Boundary Items */
|
INTEGER4 NumBItems = 0; /* No Boundary Items */
|
||||||
@ -206,16 +206,16 @@ Pout<< "zoneName:" << zoneName
|
|||||||
!TECZNE112
|
!TECZNE112
|
||||||
(
|
(
|
||||||
const_cast<char*>(zoneName.c_str()),
|
const_cast<char*>(zoneName.c_str()),
|
||||||
&ZoneType,
|
&ZoneType,
|
||||||
&NumNodes,
|
&NumNodes,
|
||||||
&NumElems,
|
&NumElems,
|
||||||
&NumFaces,
|
&NumFaces,
|
||||||
&ICellMax,
|
&ICellMax,
|
||||||
&JCellMax,
|
&JCellMax,
|
||||||
&KCellMax,
|
&KCellMax,
|
||||||
&SolTime,
|
&SolTime,
|
||||||
&strandID,
|
&strandID,
|
||||||
&ParentZone,
|
&ParentZone,
|
||||||
&IsBlock,
|
&IsBlock,
|
||||||
&NFConns,
|
&NFConns,
|
||||||
&FNMode,
|
&FNMode,
|
||||||
@ -257,11 +257,11 @@ void Foam::tecplotWriter::writeOrderedZone
|
|||||||
|
|
||||||
INTEGER4 IsBlock = 1; /* block format */
|
INTEGER4 IsBlock = 1; /* block format */
|
||||||
|
|
||||||
INTEGER4 NFConns = 0; /* not used for FEPolyhedron
|
INTEGER4 NFConns = 0; /* not used for FEPolyhedron
|
||||||
* zones
|
* zones
|
||||||
*/
|
*/
|
||||||
INTEGER4 FNMode = 0; /* not used for FEPolyhedron
|
INTEGER4 FNMode = 0; /* not used for FEPolyhedron
|
||||||
* zones
|
* zones
|
||||||
*/
|
*/
|
||||||
INTEGER4 NumFaceNodes = 1;
|
INTEGER4 NumFaceNodes = 1;
|
||||||
INTEGER4 NumBConns = 1; /* No Boundary Connections */
|
INTEGER4 NumBConns = 1; /* No Boundary Connections */
|
||||||
@ -274,9 +274,9 @@ Pout<< "zoneName:" << zoneName
|
|||||||
<< endl;
|
<< endl;
|
||||||
|
|
||||||
|
|
||||||
INTEGER4 *PassiveVarArray = NULL;
|
INTEGER4 *PassiveVarArray = NULL;
|
||||||
INTEGER4 *VarShareArray = NULL;
|
INTEGER4 *VarShareArray = NULL;
|
||||||
INTEGER4 ShrConn = 0;
|
INTEGER4 ShrConn = 0;
|
||||||
|
|
||||||
|
|
||||||
INTEGER4 ZoneType = ZoneType_Ordered;
|
INTEGER4 ZoneType = ZoneType_Ordered;
|
||||||
@ -286,16 +286,16 @@ Pout<< "zoneName:" << zoneName
|
|||||||
!TECZNE112
|
!TECZNE112
|
||||||
(
|
(
|
||||||
const_cast<char*>(zoneName.c_str()),
|
const_cast<char*>(zoneName.c_str()),
|
||||||
&ZoneType,
|
&ZoneType,
|
||||||
&IMax,
|
&IMax,
|
||||||
&JMax,
|
&JMax,
|
||||||
&KMax,
|
&KMax,
|
||||||
&ICellMax,
|
&ICellMax,
|
||||||
&JCellMax,
|
&JCellMax,
|
||||||
&KCellMax,
|
&KCellMax,
|
||||||
&SolTime,
|
&SolTime,
|
||||||
&strandID,
|
&strandID,
|
||||||
&ParentZone,
|
&ParentZone,
|
||||||
&IsBlock,
|
&IsBlock,
|
||||||
&NFConns,
|
&NFConns,
|
||||||
&FNMode,
|
&FNMode,
|
||||||
@ -382,7 +382,7 @@ void Foam::tecplotWriter::writeConnectivity(const fvMesh& mesh) const
|
|||||||
{
|
{
|
||||||
// FatalErrorIn("tecplotWriter::writeConnectivity(const fvMesh&) const")
|
// FatalErrorIn("tecplotWriter::writeConnectivity(const fvMesh&) const")
|
||||||
// << "Error in TECPOLY112." << exit(FatalError);
|
// << "Error in TECPOLY112." << exit(FatalError);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
@ -392,11 +392,11 @@ void Foam::tecplotWriter::writeConnectivity
|
|||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
INTEGER4 NumFaces = pp.nEdges(); /* number of unique faces */
|
INTEGER4 NumFaces = pp.nEdges(); /* number of unique faces */
|
||||||
INTEGER4 NumFaceNodes = 2*pp.nEdges();
|
INTEGER4 NumFaceNodes = 2*pp.nEdges();
|
||||||
|
|
||||||
// All faces (=edges) have 2 nodes
|
// All faces (=edges) have 2 nodes
|
||||||
List<INTEGER4> FaceNodeCounts(NumFaces, 2);
|
List<INTEGER4> FaceNodeCounts(NumFaces, 2);
|
||||||
|
|
||||||
List<INTEGER4> FaceNodes(NumFaceNodes);
|
List<INTEGER4> FaceNodes(NumFaceNodes);
|
||||||
label nodeI = 0;
|
label nodeI = 0;
|
||||||
forAll(pp.edges(), edgeI)
|
forAll(pp.edges(), edgeI)
|
||||||
@ -413,21 +413,21 @@ void Foam::tecplotWriter::writeConnectivity
|
|||||||
|
|
||||||
/* Define the right and left elements of each face.
|
/* Define the right and left elements of each face.
|
||||||
*
|
*
|
||||||
* The last step for writing out the polyhedral data is to
|
* The last step for writing out the polyhedral data is to
|
||||||
* define the right and left neighboring elements for each
|
* define the right and left neighboring elements for each
|
||||||
* face. The neighboring elements can be determined using the
|
* face. The neighboring elements can be determined using the
|
||||||
* right-hand rule. For each face, place your right-hand along
|
* right-hand rule. For each face, place your right-hand along
|
||||||
* the face which your fingers pointing the direction of
|
* the face which your fingers pointing the direction of
|
||||||
* incrementing node numbers (i.e. from node 1 to node 2).
|
* incrementing node numbers (i.e. from node 1 to node 2).
|
||||||
* Your right thumb will point towards the right element; the
|
* Your right thumb will point towards the right element; the
|
||||||
* element on the other side of your hand is the left element.
|
* element on the other side of your hand is the left element.
|
||||||
*
|
*
|
||||||
* The number zero is used to indicate that there isn't an
|
* The number zero is used to indicate that there isn't an
|
||||||
* element on that side of the face.
|
* element on that side of the face.
|
||||||
*
|
*
|
||||||
* Because of the way we numbered the nodes and faces, the
|
* Because of the way we numbered the nodes and faces, the
|
||||||
* right element for every face is the element itself
|
* right element for every face is the element itself
|
||||||
* (element 1) and the left element is "no-neighboring element"
|
* (element 1) and the left element is "no-neighboring element"
|
||||||
* (element 0).
|
* (element 0).
|
||||||
*/
|
*/
|
||||||
|
|
||||||
@ -508,7 +508,7 @@ Pout<< "writeEnd" << endl;
|
|||||||
{
|
{
|
||||||
// FatalErrorIn("tecplotWriter::writeEnd() const")
|
// FatalErrorIn("tecplotWriter::writeEnd() const")
|
||||||
// << "Error in TECEND112." << exit(FatalError);
|
// << "Error in TECEND112." << exit(FatalError);
|
||||||
}
|
}
|
||||||
|
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -53,7 +53,7 @@ Foam::internalWriter::internalWriter
|
|||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write topology
|
// Write topology
|
||||||
//
|
//
|
||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
|
|
||||||
const labelList& addPointCellLabels = topo.addPointCellLabels();
|
const labelList& addPointCellLabels = topo.addPointCellLabels();
|
||||||
|
|||||||
@ -26,7 +26,7 @@ InClass
|
|||||||
Foam::readFields
|
Foam::readFields
|
||||||
|
|
||||||
Description
|
Description
|
||||||
|
|
||||||
SourceFiles
|
SourceFiles
|
||||||
readFields.C
|
readFields.C
|
||||||
|
|
||||||
|
|||||||
@ -69,7 +69,7 @@ Foam::vtkTopo::vtkTopo(const polyMesh& mesh)
|
|||||||
{
|
{
|
||||||
const cellModel& model = cellShapes[cellI].model();
|
const cellModel& model = cellShapes[cellI].model();
|
||||||
|
|
||||||
if
|
if
|
||||||
(
|
(
|
||||||
model != hex
|
model != hex
|
||||||
// && model != wedge // See above.
|
// && model != wedge // See above.
|
||||||
|
|||||||
@ -66,7 +66,7 @@ void writeFaceSet
|
|||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write topology
|
// Write topology
|
||||||
//
|
//
|
||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
|
|
||||||
|
|
||||||
@ -127,7 +127,7 @@ void writeFaceSet
|
|||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write data
|
// Write data
|
||||||
//
|
//
|
||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
|
|
||||||
// Write faceID
|
// Write faceID
|
||||||
|
|||||||
@ -62,7 +62,7 @@ void writePointSet
|
|||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write topology
|
// Write topology
|
||||||
//
|
//
|
||||||
//------------------------------------------------------------------
|
//------------------------------------------------------------------
|
||||||
|
|
||||||
|
|
||||||
@ -84,7 +84,7 @@ void writePointSet
|
|||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
//
|
//
|
||||||
// Write data
|
// Write data
|
||||||
//
|
//
|
||||||
//-----------------------------------------------------------------
|
//-----------------------------------------------------------------
|
||||||
|
|
||||||
// Write faceID
|
// Write faceID
|
||||||
|
|||||||
@ -71,7 +71,7 @@ void writeSurfFields
|
|||||||
|
|
||||||
for (label faceI = 0; faceI < mesh.nFaces(); faceI++)
|
for (label faceI = 0; faceI < mesh.nFaces(); faceI++)
|
||||||
{
|
{
|
||||||
writeFuns::insert(fc[faceI], pField);
|
writeFuns::insert(fc[faceI], pField);
|
||||||
}
|
}
|
||||||
|
|
||||||
writeFuns::write(str, binary, pField);
|
writeFuns::write(str, binary, pField);
|
||||||
|
|||||||
@ -67,7 +67,7 @@ class vtkIndent;
|
|||||||
|
|
||||||
namespace Foam
|
namespace Foam
|
||||||
{
|
{
|
||||||
namespace vtkPV3Readers
|
namespace vtkPV3Readers
|
||||||
{
|
{
|
||||||
//- Declare name of the class and its debug switch
|
//- Declare name of the class and its debug switch
|
||||||
NamespaceName("vtkPV3Readers");
|
NamespaceName("vtkPV3Readers");
|
||||||
|
|||||||
@ -75,13 +75,13 @@ if (which_type == Z_PEN06)
|
|||||||
if (which_type == Z_PYR05)
|
if (which_type == Z_PYR05)
|
||||||
{
|
{
|
||||||
const cellModel& pyr = *(cellModeller::lookup("pyr"));
|
const cellModel& pyr = *(cellModeller::lookup("pyr"));
|
||||||
|
|
||||||
label counter = 1;
|
label counter = 1;
|
||||||
for (label n=0; n<nCells; n++)
|
for (label n=0; n<nCells; n++)
|
||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
const cellModel& cellModel = cellShape.model();
|
const cellModel& cellModel = cellShape.model();
|
||||||
|
|
||||||
if (cellModel == pyr)
|
if (cellModel == pyr)
|
||||||
{
|
{
|
||||||
var_array[counter++] = scalarField[n];
|
var_array[counter++] = scalarField[n];
|
||||||
|
|||||||
@ -58,12 +58,12 @@ if (which_type == Z_PEN06)
|
|||||||
{
|
{
|
||||||
const cellModel& prism = *(cellModeller::lookup("prism"));
|
const cellModel& prism = *(cellModeller::lookup("prism"));
|
||||||
|
|
||||||
label counter = 1;
|
label counter = 1;
|
||||||
for (label n=0; n<nCells; n++)
|
for (label n=0; n<nCells; n++)
|
||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
const cellModel& cellModel = cellShape.model();
|
const cellModel& cellModel = cellShape.model();
|
||||||
|
|
||||||
if (cellModel == prism)
|
if (cellModel == prism)
|
||||||
{
|
{
|
||||||
# include "tensorConversion.H"
|
# include "tensorConversion.H"
|
||||||
@ -76,7 +76,7 @@ if (which_type == Z_PYR05)
|
|||||||
{
|
{
|
||||||
const cellModel& pyr = *(cellModeller::lookup("pyr"));
|
const cellModel& pyr = *(cellModeller::lookup("pyr"));
|
||||||
|
|
||||||
label counter = 1;
|
label counter = 1;
|
||||||
for (label n=0; n<nCells; n++)
|
for (label n=0; n<nCells; n++)
|
||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
@ -96,7 +96,7 @@ if (which_type == Z_TET04)
|
|||||||
const cellModel& tet = *(cellModeller::lookup("tet"));
|
const cellModel& tet = *(cellModeller::lookup("tet"));
|
||||||
|
|
||||||
label counter = 1;
|
label counter = 1;
|
||||||
|
|
||||||
for (label n=0; n<nCells; n++)
|
for (label n=0; n<nCells; n++)
|
||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
|
|||||||
@ -45,7 +45,7 @@ if (which_type == Z_HEX08)
|
|||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
const cellModel& cellModel = cellShape.model();
|
const cellModel& cellModel = cellShape.model();
|
||||||
|
|
||||||
if (cellModel == hex) // || (cellModel == wedge))
|
if (cellModel == hex) // || (cellModel == wedge))
|
||||||
{
|
{
|
||||||
var_array[counter++] = vectorField[n][component];
|
var_array[counter++] = vectorField[n][component];
|
||||||
@ -58,7 +58,7 @@ if (which_type == Z_PEN06)
|
|||||||
{
|
{
|
||||||
const cellModel& prism = *(cellModeller::lookup("prism"));
|
const cellModel& prism = *(cellModeller::lookup("prism"));
|
||||||
|
|
||||||
label counter = 1;
|
label counter = 1;
|
||||||
for (label n=0; n<nCells; n++)
|
for (label n=0; n<nCells; n++)
|
||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
@ -76,12 +76,12 @@ if (which_type == Z_PYR05)
|
|||||||
{
|
{
|
||||||
const cellModel& pyr = *(cellModeller::lookup("pyr"));
|
const cellModel& pyr = *(cellModeller::lookup("pyr"));
|
||||||
|
|
||||||
label counter = 1;
|
label counter = 1;
|
||||||
for (label n=0; n<nCells; n++)
|
for (label n=0; n<nCells; n++)
|
||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
const cellModel& cellModel = cellShape.model();
|
const cellModel& cellModel = cellShape.model();
|
||||||
|
|
||||||
if (cellModel == pyr)
|
if (cellModel == pyr)
|
||||||
{
|
{
|
||||||
var_array[counter++] = vectorField[n][component];
|
var_array[counter++] = vectorField[n][component];
|
||||||
@ -95,7 +95,7 @@ if (which_type == Z_TET04)
|
|||||||
{
|
{
|
||||||
const cellModel& tet = *(cellModeller::lookup("tet"));
|
const cellModel& tet = *(cellModeller::lookup("tet"));
|
||||||
|
|
||||||
label counter = 1;
|
label counter = 1;
|
||||||
for (label n=0; n<nCells; n++)
|
for (label n=0; n<nCells; n++)
|
||||||
{
|
{
|
||||||
const cellShape& cellShape = cellShapes[n];
|
const cellShape& cellShape = cellShapes[n];
|
||||||
|
|||||||
@ -82,7 +82,7 @@ void Foam::channelIndex::walkOppositeFaces
|
|||||||
}
|
}
|
||||||
syncTools::swapBoundaryFaceList(mesh, isFrontBndFace, false);
|
syncTools::swapBoundaryFaceList(mesh, isFrontBndFace, false);
|
||||||
|
|
||||||
// Add
|
// Add
|
||||||
forAll(isFrontBndFace, i)
|
forAll(isFrontBndFace, i)
|
||||||
{
|
{
|
||||||
label faceI = mesh.nInternalFaces()+i;
|
label faceI = mesh.nInternalFaces()+i;
|
||||||
|
|||||||
@ -202,7 +202,7 @@ inline bool Foam::sumData::updateFace
|
|||||||
{
|
{
|
||||||
return false;
|
return false;
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
// * * * * * * * * * * * * * * * Member Operators * * * * * * * * * * * * * //
|
// * * * * * * * * * * * * * * * Member Operators * * * * * * * * * * * * * //
|
||||||
|
|||||||
@ -197,7 +197,7 @@ static void splitTri
|
|||||||
// Insert scalar into sortedVerts/sortedWeights so the weights are in
|
// Insert scalar into sortedVerts/sortedWeights so the weights are in
|
||||||
// incrementing order.
|
// incrementing order.
|
||||||
static bool insertSorted
|
static bool insertSorted
|
||||||
(
|
(
|
||||||
const label vertI,
|
const label vertI,
|
||||||
const scalar weight,
|
const scalar weight,
|
||||||
|
|
||||||
@ -243,7 +243,7 @@ static bool insertSorted
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
label sz = sortedWeights.size();
|
label sz = sortedWeights.size();
|
||||||
|
|
||||||
sortedWeights.setSize(sz + 1);
|
sortedWeights.setSize(sz + 1);
|
||||||
@ -292,7 +292,7 @@ static void markCollapsedFaces
|
|||||||
// Check distance of vertex to edge.
|
// Check distance of vertex to edge.
|
||||||
label opposite0 =
|
label opposite0 =
|
||||||
triSurfaceTools::oppositeVertex
|
triSurfaceTools::oppositeVertex
|
||||||
(
|
(
|
||||||
surf,
|
surf,
|
||||||
faceI,
|
faceI,
|
||||||
edgeI
|
edgeI
|
||||||
@ -481,7 +481,7 @@ static label edgeType
|
|||||||
{
|
{
|
||||||
if (usesRegion == -1)
|
if (usesRegion == -1)
|
||||||
{
|
{
|
||||||
FatalErrorIn("edgeRegion") << abort(FatalError);
|
FatalErrorIn("edgeRegion") << abort(FatalError);
|
||||||
return -2;
|
return -2;
|
||||||
}
|
}
|
||||||
else
|
else
|
||||||
@ -750,9 +750,9 @@ label collapseBase(triSurface& surf, const scalar minLen)
|
|||||||
// Find regions of connected collapsed faces
|
// Find regions of connected collapsed faces
|
||||||
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
|
||||||
|
|
||||||
// per face -1 or region
|
// per face -1 or region
|
||||||
labelList collapseRegion(surf.size(), -1);
|
labelList collapseRegion(surf.size(), -1);
|
||||||
|
|
||||||
label nRegions = markRegions(surf, faceToEdge, collapseRegion);
|
label nRegions = markRegions(surf, faceToEdge, collapseRegion);
|
||||||
|
|
||||||
Pout<< "Detected " << nRegions << " regions of faces to be collapsed"
|
Pout<< "Detected " << nRegions << " regions of faces to be collapsed"
|
||||||
@ -783,7 +783,7 @@ label collapseBase(triSurface& surf, const scalar minLen)
|
|||||||
(
|
(
|
||||||
surf,
|
surf,
|
||||||
outsideVerts[regionI],
|
outsideVerts[regionI],
|
||||||
spanPoints[regionI],
|
spanPoints[regionI],
|
||||||
orderedVertices[regionI],
|
orderedVertices[regionI],
|
||||||
orderedWeights[regionI]
|
orderedWeights[regionI]
|
||||||
);
|
);
|
||||||
@ -862,7 +862,7 @@ label collapseBase(triSurface& surf, const scalar minLen)
|
|||||||
|
|
||||||
if (splitVerts.size())
|
if (splitVerts.size())
|
||||||
{
|
{
|
||||||
// Split edge using splitVerts. All non-collapsed triangles
|
// Split edge using splitVerts. All non-collapsed triangles
|
||||||
// using edge will get split.
|
// using edge will get split.
|
||||||
|
|
||||||
|
|
||||||
|
|||||||
@ -58,7 +58,7 @@ static triSurface pack
|
|||||||
{
|
{
|
||||||
List<labelledTri> newTriangles(surf.size());
|
List<labelledTri> newTriangles(surf.size());
|
||||||
label newTriangleI = 0;
|
label newTriangleI = 0;
|
||||||
|
|
||||||
forAll(surf, faceI)
|
forAll(surf, faceI)
|
||||||
{
|
{
|
||||||
const labelledTri& f = surf.localFaces()[faceI];
|
const labelledTri& f = surf.localFaces()[faceI];
|
||||||
|
|||||||
@ -23,7 +23,7 @@ License
|
|||||||
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
||||||
|
|
||||||
Application
|
Application
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Calculates the equilibrium level of carbon monoxide
|
Calculates the equilibrium level of carbon monoxide
|
||||||
|
|
||||||
|
|||||||
@ -405,7 +405,7 @@ void Foam::FaceCellWave<Type>::leaveDomain
|
|||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
const vectorField& fc = mesh_.faceCentres();
|
const vectorField& fc = mesh_.faceCentres();
|
||||||
|
|
||||||
for (label i = 0; i < nFaces; i++)
|
for (label i = 0; i < nFaces; i++)
|
||||||
{
|
{
|
||||||
label patchFaceI = faceLabels[i];
|
label patchFaceI = faceLabels[i];
|
||||||
@ -427,7 +427,7 @@ void Foam::FaceCellWave<Type>::enterDomain
|
|||||||
) const
|
) const
|
||||||
{
|
{
|
||||||
const vectorField& fc = mesh_.faceCentres();
|
const vectorField& fc = mesh_.faceCentres();
|
||||||
|
|
||||||
for (label i = 0; i < nFaces; i++)
|
for (label i = 0; i < nFaces; i++)
|
||||||
{
|
{
|
||||||
label patchFaceI = faceLabels[i];
|
label patchFaceI = faceLabels[i];
|
||||||
@ -739,7 +739,7 @@ void Foam::FaceCellWave<Type>::handleCyclicPatches()
|
|||||||
|
|
||||||
if (debug)
|
if (debug)
|
||||||
{
|
{
|
||||||
Pout<< " Cyclic patch " << patchI << ' ' << patch.name()
|
Pout<< " Cyclic patch " << patchI << ' ' << patch.name()
|
||||||
<< " Changed on first half : " << nSendFaces
|
<< " Changed on first half : " << nSendFaces
|
||||||
<< " Changed on second half : " << nReceiveFaces
|
<< " Changed on second half : " << nReceiveFaces
|
||||||
<< endl;
|
<< endl;
|
||||||
@ -819,7 +819,7 @@ Foam::FaceCellWave<Type>::FaceCellWave
|
|||||||
{}
|
{}
|
||||||
|
|
||||||
|
|
||||||
// Iterate, propagating changedFacesInfo across mesh, until no change (or
|
// Iterate, propagating changedFacesInfo across mesh, until no change (or
|
||||||
// maxIter reached). Initial cell values specified.
|
// maxIter reached). Initial cell values specified.
|
||||||
template <class Type>
|
template <class Type>
|
||||||
Foam::FaceCellWave<Type>::FaceCellWave
|
Foam::FaceCellWave<Type>::FaceCellWave
|
||||||
|
|||||||
@ -331,7 +331,7 @@ public:
|
|||||||
|
|
||||||
//- Access mesh
|
//- Access mesh
|
||||||
const polyMesh& mesh() const
|
const polyMesh& mesh() const
|
||||||
{
|
{
|
||||||
return mesh_;
|
return mesh_;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -29,7 +29,7 @@ License
|
|||||||
|
|
||||||
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
|
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
|
||||||
|
|
||||||
// Iterate, propagating changedFacesInfo across mesh, until no change (or
|
// Iterate, propagating changedFacesInfo across mesh, until no change (or
|
||||||
// maxIter reached).
|
// maxIter reached).
|
||||||
template <class Type>
|
template <class Type>
|
||||||
Foam::MeshWave<Type>::MeshWave
|
Foam::MeshWave<Type>::MeshWave
|
||||||
@ -54,7 +54,7 @@ Foam::MeshWave<Type>::MeshWave
|
|||||||
{}
|
{}
|
||||||
|
|
||||||
|
|
||||||
// Iterate, propagating changedFacesInfo across mesh, until no change (or
|
// Iterate, propagating changedFacesInfo across mesh, until no change (or
|
||||||
// maxIter reached). Initial cell values specified.
|
// maxIter reached). Initial cell values specified.
|
||||||
template <class Type>
|
template <class Type>
|
||||||
Foam::MeshWave<Type>::MeshWave
|
Foam::MeshWave<Type>::MeshWave
|
||||||
|
|||||||
@ -48,7 +48,7 @@ void reduce
|
|||||||
{
|
{
|
||||||
Pstream::gather(comms, Value, bop);
|
Pstream::gather(comms, Value, bop);
|
||||||
Pstream::scatter(comms, Value);
|
Pstream::scatter(comms, Value);
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
// Reduce using either linear or tree communication schedule
|
// Reduce using either linear or tree communication schedule
|
||||||
@ -67,7 +67,7 @@ void reduce
|
|||||||
{
|
{
|
||||||
reduce(UPstream::treeCommunication(), Value, bop);
|
reduce(UPstream::treeCommunication(), Value, bop);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
// Reduce using either linear or tree communication schedule
|
// Reduce using either linear or tree communication schedule
|
||||||
@ -90,7 +90,7 @@ T returnReduce
|
|||||||
}
|
}
|
||||||
|
|
||||||
return WorkValue;
|
return WorkValue;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
// Insist there is a specialisation for the reduction of a scalar
|
// Insist there is a specialisation for the reduction of a scalar
|
||||||
|
|||||||
@ -146,7 +146,7 @@ such a program is covered only if its contents constitute a work based
|
|||||||
on the Library (independent of the use of the Library in a tool for
|
on the Library (independent of the use of the Library in a tool for
|
||||||
writing it). Whether that is true depends on what the Library does
|
writing it). Whether that is true depends on what the Library does
|
||||||
and what the program that uses the Library does.
|
and what the program that uses the Library does.
|
||||||
|
|
||||||
1. You may copy and distribute verbatim copies of the Library's
|
1. You may copy and distribute verbatim copies of the Library's
|
||||||
complete source code as you receive it, in any medium, provided that
|
complete source code as you receive it, in any medium, provided that
|
||||||
you conspicuously and appropriately publish on each copy an
|
you conspicuously and appropriately publish on each copy an
|
||||||
|
|||||||
@ -21,9 +21,9 @@
|
|||||||
// Revision : $Revision: 1.8 $
|
// Revision : $Revision: 1.8 $
|
||||||
// Revision_date : $Date: 2005/12/07 18:03:25 $
|
// Revision_date : $Date: 2005/12/07 18:03:25 $
|
||||||
// Author(s) : Deepak Bandyopadhyay, Lutz Kettner
|
// Author(s) : Deepak Bandyopadhyay, Lutz Kettner
|
||||||
//
|
//
|
||||||
// Standard streambuf implementation following Nicolai Josuttis, "The
|
// Standard streambuf implementation following Nicolai Josuttis,
|
||||||
// Standard C++ Library".
|
// "The Standard C++ Library".
|
||||||
// ============================================================================
|
// ============================================================================
|
||||||
|
|
||||||
#include "gzstream.h"
|
#include "gzstream.h"
|
||||||
@ -97,7 +97,7 @@ int gzstreambuf::underflow() { // used for input buffer only
|
|||||||
buffer + 4 + num); // end of buffer
|
buffer + 4 + num); // end of buffer
|
||||||
|
|
||||||
// return next character
|
// return next character
|
||||||
return * reinterpret_cast<unsigned char *>( gptr());
|
return * reinterpret_cast<unsigned char *>( gptr());
|
||||||
}
|
}
|
||||||
|
|
||||||
int gzstreambuf::flush_buffer() {
|
int gzstreambuf::flush_buffer() {
|
||||||
|
|||||||
@ -21,9 +21,9 @@
|
|||||||
// Revision : $Revision: 1.8 $
|
// Revision : $Revision: 1.8 $
|
||||||
// Revision_date : $Date: 2005/11/09 13:53:50 $
|
// Revision_date : $Date: 2005/11/09 13:53:50 $
|
||||||
// Author(s) : Deepak Bandyopadhyay, Lutz Kettner
|
// Author(s) : Deepak Bandyopadhyay, Lutz Kettner
|
||||||
//
|
//
|
||||||
// Standard streambuf implementation following Nicolai Josuttis, "The
|
// Standard streambuf implementation following Nicolai Josuttis,
|
||||||
// Standard C++ Library".
|
// "The Standard C++ Library".
|
||||||
// ============================================================================
|
// ============================================================================
|
||||||
|
|
||||||
#ifndef GZSTREAM_H
|
#ifndef GZSTREAM_H
|
||||||
@ -48,21 +48,21 @@ namespace GZSTREAM_NAMESPACE {
|
|||||||
// class gzstreambuf
|
// class gzstreambuf
|
||||||
// ----------------------------------------------------------------------------
|
// ----------------------------------------------------------------------------
|
||||||
|
|
||||||
class gzstreambuf
|
class gzstreambuf
|
||||||
: public std::streambuf
|
: public std::streambuf
|
||||||
{
|
{
|
||||||
private:
|
private:
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
static const int bufferSize = 47+256;
|
static const int bufferSize = 47+256;
|
||||||
// totals 512 bytes under g++ for igzstream at the end.
|
// totals 512 bytes under g++ for igzstream at the end.
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
gzFile file;
|
gzFile file;
|
||||||
char buffer[bufferSize];
|
char buffer[bufferSize];
|
||||||
char opened;
|
char opened;
|
||||||
int mode;
|
int mode;
|
||||||
|
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
@ -73,25 +73,25 @@ public:
|
|||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
gzstreambuf()
|
gzstreambuf()
|
||||||
: opened(0)
|
: opened(0)
|
||||||
{
|
{
|
||||||
setp( buffer, buffer + (bufferSize-1));
|
setp( buffer, buffer + (bufferSize-1));
|
||||||
setg( buffer + 4, // beginning of putback area
|
setg( buffer + 4, // beginning of putback area
|
||||||
buffer + 4, // read position
|
buffer + 4, // read position
|
||||||
buffer + 4); // end position
|
buffer + 4); // end position
|
||||||
// ASSERT: both input & output capabilities will not be used together
|
// ASSERT: both input & output capabilities will not be used together
|
||||||
}
|
}
|
||||||
~gzstreambuf()
|
~gzstreambuf()
|
||||||
{
|
{
|
||||||
close();
|
close();
|
||||||
}
|
}
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
int is_open()
|
int is_open()
|
||||||
{
|
{
|
||||||
return opened;
|
return opened;
|
||||||
}
|
}
|
||||||
gzstreambuf* open( const char* name, int open_mode );
|
gzstreambuf* open( const char* name, int open_mode );
|
||||||
gzstreambuf* close();
|
gzstreambuf* close();
|
||||||
@ -104,8 +104,8 @@ public:
|
|||||||
// class gzstreambase
|
// class gzstreambase
|
||||||
// ----------------------------------------------------------------------------
|
// ----------------------------------------------------------------------------
|
||||||
|
|
||||||
class gzstreambase
|
class gzstreambase
|
||||||
: virtual public std::ios
|
: virtual public std::ios
|
||||||
{
|
{
|
||||||
protected:
|
protected:
|
||||||
|
|
||||||
@ -117,9 +117,9 @@ public:
|
|||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
gzstreambase()
|
gzstreambase()
|
||||||
{
|
{
|
||||||
init(&buf);
|
init(&buf);
|
||||||
}
|
}
|
||||||
gzstreambase( const char* _name, int _open_mode );
|
gzstreambase( const char* _name, int _open_mode );
|
||||||
~gzstreambase();
|
~gzstreambase();
|
||||||
@ -128,15 +128,15 @@ public:
|
|||||||
|
|
||||||
void open( const char* _name, int _open_mode );
|
void open( const char* _name, int _open_mode );
|
||||||
void close();
|
void close();
|
||||||
gzstreambuf* rdbuf()
|
gzstreambuf* rdbuf()
|
||||||
{
|
{
|
||||||
return &buf;
|
return &buf;
|
||||||
}
|
}
|
||||||
};
|
};
|
||||||
|
|
||||||
// ----------------------------------------------------------------------------
|
// ----------------------------------------------------------------------------
|
||||||
// User classes. Use igzstream and ogzstream analogously to ifstream and
|
// User classes. Use igzstream and ogzstream analogously to ifstream and
|
||||||
// ofstream respectively. They read and write files based on the gz*
|
// ofstream respectively. They read and write files based on the gz*
|
||||||
// function interface of the zlib. Files are compatible with gzip compression.
|
// function interface of the zlib. Files are compatible with gzip compression.
|
||||||
// ----------------------------------------------------------------------------
|
// ----------------------------------------------------------------------------
|
||||||
|
|
||||||
@ -144,30 +144,30 @@ public:
|
|||||||
// class igzstream
|
// class igzstream
|
||||||
// ----------------------------------------------------------------------------
|
// ----------------------------------------------------------------------------
|
||||||
|
|
||||||
class igzstream
|
class igzstream
|
||||||
: public std::istream
|
: public std::istream
|
||||||
, public gzstreambase
|
, public gzstreambase
|
||||||
{
|
{
|
||||||
public:
|
public:
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
igzstream()
|
igzstream()
|
||||||
: std::istream( &buf)
|
: std::istream( &buf)
|
||||||
{}
|
{}
|
||||||
igzstream( const char* _name,
|
igzstream( const char* _name,
|
||||||
int _open_mode = std::ios::in )
|
int _open_mode = std::ios::in )
|
||||||
: std::istream( &buf )
|
: std::istream( &buf )
|
||||||
, gzstreambase( _name, _open_mode )
|
, gzstreambase( _name, _open_mode )
|
||||||
{}
|
{}
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
gzstreambuf* rdbuf()
|
gzstreambuf* rdbuf()
|
||||||
{
|
{
|
||||||
return gzstreambase::rdbuf();
|
return gzstreambase::rdbuf();
|
||||||
}
|
}
|
||||||
void open( const char* _name,
|
void open( const char* _name,
|
||||||
int _open_mode = std::ios::in )
|
int _open_mode = std::ios::in )
|
||||||
{
|
{
|
||||||
gzstreambase::open( _name, _open_mode );
|
gzstreambase::open( _name, _open_mode );
|
||||||
@ -178,32 +178,32 @@ public:
|
|||||||
// class ogzstream
|
// class ogzstream
|
||||||
// ----------------------------------------------------------------------------
|
// ----------------------------------------------------------------------------
|
||||||
|
|
||||||
class ogzstream
|
class ogzstream
|
||||||
: public gzstreambase
|
: public gzstreambase
|
||||||
, public std::ostream
|
, public std::ostream
|
||||||
{
|
{
|
||||||
public:
|
public:
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
ogzstream()
|
ogzstream()
|
||||||
: std::ostream( &buf)
|
: std::ostream( &buf)
|
||||||
{}
|
{}
|
||||||
explicit
|
explicit
|
||||||
ogzstream( const char* _name,
|
ogzstream( const char* _name,
|
||||||
int _open_mode = std::ios::out )
|
int _open_mode = std::ios::out )
|
||||||
: gzstreambase( _name, _open_mode )
|
: gzstreambase( _name, _open_mode )
|
||||||
, std::ostream( &buf)
|
, std::ostream( &buf)
|
||||||
{}
|
{}
|
||||||
|
|
||||||
//------------------------------------
|
//------------------------------------
|
||||||
|
|
||||||
gzstreambuf* rdbuf()
|
gzstreambuf* rdbuf()
|
||||||
{
|
{
|
||||||
return gzstreambase::rdbuf();
|
return gzstreambase::rdbuf();
|
||||||
}
|
}
|
||||||
void open( const char* _name,
|
void open( const char* _name,
|
||||||
int _open_mode = std::ios::out )
|
int _open_mode = std::ios::out )
|
||||||
{
|
{
|
||||||
gzstreambase::open( _name, _open_mode );
|
gzstreambase::open( _name, _open_mode );
|
||||||
}
|
}
|
||||||
|
|||||||
@ -93,7 +93,7 @@ class OutputFilterFunctionObject
|
|||||||
|
|
||||||
//- Read relevant dictionary entries
|
//- Read relevant dictionary entries
|
||||||
void readDict();
|
void readDict();
|
||||||
|
|
||||||
//- Creates most of the data associated with this object.
|
//- Creates most of the data associated with this object.
|
||||||
void allocateFilter();
|
void allocateFilter();
|
||||||
|
|
||||||
|
|||||||
@ -282,7 +282,7 @@ tmp
|
|||||||
>
|
>
|
||||||
cmptAv(const tmp<DimensionedField<Type, GeoMesh> >& tdf)
|
cmptAv(const tmp<DimensionedField<Type, GeoMesh> >& tdf)
|
||||||
{
|
{
|
||||||
typedef typename DimensionedField<Type, GeoMesh>::cmptType
|
typedef typename DimensionedField<Type, GeoMesh>::cmptType
|
||||||
cmptType;
|
cmptType;
|
||||||
|
|
||||||
const DimensionedField<Type, GeoMesh>& df = tdf();
|
const DimensionedField<Type, GeoMesh>& df = tdf();
|
||||||
|
|||||||
@ -212,7 +212,7 @@ tmp<FieldField<Field, Type> > FieldField<Field, Type>::NewCalculatedType
|
|||||||
);
|
);
|
||||||
|
|
||||||
forAll(*nffPtr, i)
|
forAll(*nffPtr, i)
|
||||||
{
|
{
|
||||||
nffPtr->set(i, Field<Type>::NewCalculatedType(ff[i]).ptr());
|
nffPtr->set(i, Field<Type>::NewCalculatedType(ff[i]).ptr());
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|||||||
@ -184,7 +184,7 @@ public:
|
|||||||
//- Return a list of the patch types
|
//- Return a list of the patch types
|
||||||
wordList types() const;
|
wordList types() const;
|
||||||
|
|
||||||
//- Return BoundaryField of the cell values neighbouring
|
//- Return BoundaryField of the cell values neighbouring
|
||||||
// the boundary
|
// the boundary
|
||||||
GeometricBoundaryField boundaryInternalField() const;
|
GeometricBoundaryField boundaryInternalField() const;
|
||||||
|
|
||||||
@ -194,7 +194,7 @@ public:
|
|||||||
|
|
||||||
//- Write boundary field as dictionary entry
|
//- Write boundary field as dictionary entry
|
||||||
void writeEntry(const word& keyword, Ostream& os) const;
|
void writeEntry(const word& keyword, Ostream& os) const;
|
||||||
|
|
||||||
|
|
||||||
// Member operators
|
// Member operators
|
||||||
|
|
||||||
@ -208,7 +208,7 @@ public:
|
|||||||
void operator=(const Type&);
|
void operator=(const Type&);
|
||||||
|
|
||||||
|
|
||||||
//- Forced assignment to
|
//- Forced assignment to
|
||||||
// BoundaryField<Type, PatchField, BoundaryMesh>
|
// BoundaryField<Type, PatchField, BoundaryMesh>
|
||||||
void operator==(const GeometricBoundaryField&);
|
void operator==(const GeometricBoundaryField&);
|
||||||
|
|
||||||
@ -224,7 +224,7 @@ private:
|
|||||||
|
|
||||||
// Private data
|
// Private data
|
||||||
|
|
||||||
//- Current time index.
|
//- Current time index.
|
||||||
// Used to trigger the storing of the old-time value
|
// Used to trigger the storing of the old-time value
|
||||||
mutable label timeIndex_;
|
mutable label timeIndex_;
|
||||||
|
|
||||||
|
|||||||
@ -446,7 +446,7 @@ tmp
|
|||||||
>
|
>
|
||||||
cmptAv(const tmp<GeometricField<Type, PatchField, GeoMesh> >& tgf)
|
cmptAv(const tmp<GeometricField<Type, PatchField, GeoMesh> >& tgf)
|
||||||
{
|
{
|
||||||
typedef typename GeometricField<Type, PatchField, GeoMesh>::cmptType
|
typedef typename GeometricField<Type, PatchField, GeoMesh>::cmptType
|
||||||
cmptType;
|
cmptType;
|
||||||
|
|
||||||
const GeometricField<Type, PatchField, GeoMesh>& gf = tgf();
|
const GeometricField<Type, PatchField, GeoMesh>& gf = tgf();
|
||||||
|
|||||||
@ -1,5 +1,5 @@
|
|||||||
/*---------------------------------------------------------------------------*\
|
/*---------------------------------------------------------------------------*\
|
||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 1991-2009 OpenCFD Ltd.
|
\\ / A nd | Copyright (C) 1991-2009 OpenCFD Ltd.
|
||||||
|
|||||||
@ -1,5 +1,5 @@
|
|||||||
/*---------------------------------------------------------------------------*\
|
/*---------------------------------------------------------------------------*\
|
||||||
========= |
|
========= |
|
||||||
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
|
||||||
\\ / O peration |
|
\\ / O peration |
|
||||||
\\ / A nd | Copyright (C) 1991-2009 OpenCFD Ltd.
|
\\ / A nd | Copyright (C) 1991-2009 OpenCFD Ltd.
|
||||||
|
|||||||
@ -46,7 +46,7 @@ template<class Type, class MeshMapper, class GeoMesh>
|
|||||||
class MapInternalField
|
class MapInternalField
|
||||||
{
|
{
|
||||||
public:
|
public:
|
||||||
|
|
||||||
MapInternalField()
|
MapInternalField()
|
||||||
{}
|
{}
|
||||||
|
|
||||||
@ -82,7 +82,7 @@ void MapGeometricFields
|
|||||||
// It is necessary to enforce that all old-time fields are stored
|
// It is necessary to enforce that all old-time fields are stored
|
||||||
// before the mapping is performed. Otherwise, if the
|
// before the mapping is performed. Otherwise, if the
|
||||||
// old-time-level field is mapped before the field itself, sizes
|
// old-time-level field is mapped before the field itself, sizes
|
||||||
// will not match.
|
// will not match.
|
||||||
|
|
||||||
for
|
for
|
||||||
(
|
(
|
||||||
@ -92,7 +92,7 @@ void MapGeometricFields
|
|||||||
++fieldIter
|
++fieldIter
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
GeometricField<Type, PatchField, GeoMesh>& field =
|
GeometricField<Type, PatchField, GeoMesh>& field =
|
||||||
const_cast<GeometricField<Type, PatchField, GeoMesh>&>
|
const_cast<GeometricField<Type, PatchField, GeoMesh>&>
|
||||||
(*fieldIter());
|
(*fieldIter());
|
||||||
|
|
||||||
@ -112,7 +112,7 @@ void MapGeometricFields
|
|||||||
++fieldIter
|
++fieldIter
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
GeometricField<Type, PatchField, GeoMesh>& field =
|
GeometricField<Type, PatchField, GeoMesh>& field =
|
||||||
const_cast<GeometricField<Type, PatchField, GeoMesh>&>
|
const_cast<GeometricField<Type, PatchField, GeoMesh>&>
|
||||||
(*fieldIter());
|
(*fieldIter());
|
||||||
|
|
||||||
@ -137,7 +137,7 @@ void MapGeometricFields
|
|||||||
// Cannot check sizes for patch fields because of
|
// Cannot check sizes for patch fields because of
|
||||||
// empty fields in FV and because point fields get their size
|
// empty fields in FV and because point fields get their size
|
||||||
// from the patch which has already been resized
|
// from the patch which has already been resized
|
||||||
//
|
//
|
||||||
|
|
||||||
field.boundaryField()[patchi].autoMap
|
field.boundaryField()[patchi].autoMap
|
||||||
(
|
(
|
||||||
|
|||||||
@ -88,7 +88,7 @@ tmp<GeometricField<Type, PatchField, GeoMesh> > transform
|
|||||||
const tmp<GeometricField<Type, PatchField, GeoMesh> >& ttf
|
const tmp<GeometricField<Type, PatchField, GeoMesh> >& ttf
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
||||||
transform(trf, ttf());
|
transform(trf, ttf());
|
||||||
ttf.clear();
|
ttf.clear();
|
||||||
return tranf;
|
return tranf;
|
||||||
@ -102,7 +102,7 @@ tmp<GeometricField<Type, PatchField, GeoMesh> > transform
|
|||||||
const GeometricField<Type, PatchField, GeoMesh>& tf
|
const GeometricField<Type, PatchField, GeoMesh>& tf
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
||||||
transform(ttrf(), tf);
|
transform(ttrf(), tf);
|
||||||
ttrf.clear();
|
ttrf.clear();
|
||||||
return tranf;
|
return tranf;
|
||||||
@ -116,7 +116,7 @@ tmp<GeometricField<Type, PatchField, GeoMesh> > transform
|
|||||||
const tmp<GeometricField<Type, PatchField, GeoMesh> >& ttf
|
const tmp<GeometricField<Type, PatchField, GeoMesh> >& ttf
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
||||||
transform(ttrf(), ttf());
|
transform(ttrf(), ttf());
|
||||||
ttf.clear();
|
ttf.clear();
|
||||||
ttrf.clear();
|
ttrf.clear();
|
||||||
@ -174,7 +174,7 @@ tmp<GeometricField<Type, PatchField, GeoMesh> > transform
|
|||||||
const tmp<GeometricField<Type, PatchField, GeoMesh> >& ttf
|
const tmp<GeometricField<Type, PatchField, GeoMesh> >& ttf
|
||||||
)
|
)
|
||||||
{
|
{
|
||||||
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
tmp<GeometricField<Type, PatchField, GeoMesh> > tranf =
|
||||||
transform(t, ttf());
|
transform(t, ttf());
|
||||||
ttf.clear();
|
ttf.clear();
|
||||||
return tranf;
|
return tranf;
|
||||||
|
|||||||
@ -124,7 +124,7 @@ Foam::wordList Foam::ReadFields
|
|||||||
)
|
)
|
||||||
);
|
);
|
||||||
}
|
}
|
||||||
return masterNames;
|
return masterNames;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
|
|||||||
@ -28,7 +28,7 @@ Class
|
|||||||
Description
|
Description
|
||||||
Accumulates point constraints through successive applications of the
|
Accumulates point constraints through successive applications of the
|
||||||
applyConstraint function.
|
applyConstraint function.
|
||||||
|
|
||||||
After all the constraints have been entered the resulting
|
After all the constraints have been entered the resulting
|
||||||
transformation tensor is returned by the constraintTransformation
|
transformation tensor is returned by the constraintTransformation
|
||||||
function.
|
function.
|
||||||
@ -74,7 +74,7 @@ public:
|
|||||||
|
|
||||||
// Member Functions
|
// Member Functions
|
||||||
|
|
||||||
//- Apply and accumulate the effect of the given constraint direction
|
//- Apply and accumulate the effect of the given constraint direction
|
||||||
inline void applyConstraint(const vector& cd);
|
inline void applyConstraint(const vector& cd);
|
||||||
|
|
||||||
//- Return the accumulated constraint transformation tensor
|
//- Return the accumulated constraint transformation tensor
|
||||||
|
|||||||
@ -77,7 +77,7 @@ public:
|
|||||||
SYMBOL_WITH_ERROR_BARS,
|
SYMBOL_WITH_ERROR_BARS,
|
||||||
SYMBOL_WITH_VARIABLE_SIZE
|
SYMBOL_WITH_VARIABLE_SIZE
|
||||||
};
|
};
|
||||||
|
|
||||||
|
|
||||||
private:
|
private:
|
||||||
|
|
||||||
|
|||||||
@ -209,16 +209,16 @@ public:
|
|||||||
(),
|
(),
|
||||||
()
|
()
|
||||||
);
|
);
|
||||||
|
|
||||||
|
|
||||||
// Selectors
|
// Selectors
|
||||||
|
|
||||||
//- Return a reference to the selected writer
|
//- Return a reference to the selected writer
|
||||||
static autoPtr<writer> New
|
static autoPtr<writer> New
|
||||||
(
|
(
|
||||||
const word& writeFormat
|
const word& writeFormat
|
||||||
);
|
);
|
||||||
|
|
||||||
|
|
||||||
// Constructors
|
// Constructors
|
||||||
|
|
||||||
|
|||||||
@ -27,7 +27,7 @@ Class
|
|||||||
|
|
||||||
Description
|
Description
|
||||||
jplot graph output
|
jplot graph output
|
||||||
|
|
||||||
SourceFiles
|
SourceFiles
|
||||||
jplotGraph.C
|
jplotGraph.C
|
||||||
|
|
||||||
|
|||||||
@ -7,6 +7,6 @@
|
|||||||
|
|
||||||
// unless -constant is present, skip startTime if it is "constant"
|
// unless -constant is present, skip startTime if it is "constant"
|
||||||
# include "checkConstantOption.H"
|
# include "checkConstantOption.H"
|
||||||
|
|
||||||
// check -time and -latestTime options
|
// check -time and -latestTime options
|
||||||
# include "checkTimeOption.H"
|
# include "checkTimeOption.H"
|
||||||
|
|||||||
@ -91,7 +91,7 @@ public:
|
|||||||
{
|
{
|
||||||
return autoPtr<procLduInterface>(new procLduInterface(is));
|
return autoPtr<procLduInterface>(new procLduInterface(is));
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
// Ostream operator
|
// Ostream operator
|
||||||
|
|
||||||
|
|||||||
Some files were not shown because too many files have changed in this diff Show More
Reference in New Issue
Block a user