mirror of
https://github.com/ParticulateFlow/CFDEMcoupling-PFM.git
synced 2025-12-08 06:37:44 +00:00
clean up whitespaces
remove extra spaces, convert tabs to spaces
This commit is contained in:
@ -6,8 +6,8 @@
|
|||||||
particleCloud.energyContributions(Qsource);
|
particleCloud.energyContributions(Qsource);
|
||||||
particleCloud.energyCoefficients(QCoeff);
|
particleCloud.energyCoefficients(QCoeff);
|
||||||
|
|
||||||
//thDiff=particleCloud.thermCondM().thermDiff();
|
//thDiff=particleCloud.thermCondM().thermDiff();
|
||||||
thCond=particleCloud.thermCondM().thermCond();
|
thCond=particleCloud.thermCondM().thermCond();
|
||||||
|
|
||||||
addSource = fvc::ddt(rhoeps, K) + fvc::div(phi, K)
|
addSource = fvc::ddt(rhoeps, K) + fvc::div(phi, K)
|
||||||
+ (
|
+ (
|
||||||
|
|||||||
@ -6,7 +6,7 @@ volScalarField& he = thermo.he();
|
|||||||
particleCloud.energyContributions(Qsource);
|
particleCloud.energyContributions(Qsource);
|
||||||
particleCloud.energyCoefficients(QCoeff);
|
particleCloud.energyCoefficients(QCoeff);
|
||||||
|
|
||||||
thCond=particleCloud.thermCondM().thermCond();
|
thCond=particleCloud.thermCondM().thermCond();
|
||||||
Cpv = he.name() == "e" ? thermo.Cv() : thermo.Cp();
|
Cpv = he.name() == "e" ? thermo.Cv() : thermo.Cp();
|
||||||
|
|
||||||
fvScalarMatrix EEqn
|
fvScalarMatrix EEqn
|
||||||
|
|||||||
@ -64,7 +64,7 @@ int main(int argc, char *argv[])
|
|||||||
#include "createFieldRefs.H"
|
#include "createFieldRefs.H"
|
||||||
#include "createFvOptions.H"
|
#include "createFvOptions.H"
|
||||||
#include "initContinuityErrs.H"
|
#include "initContinuityErrs.H"
|
||||||
|
|
||||||
// create cfdemCloud
|
// create cfdemCloud
|
||||||
#include "readGravitationalAcceleration.H"
|
#include "readGravitationalAcceleration.H"
|
||||||
cfdemCloudEnergy particleCloud(mesh);
|
cfdemCloudEnergy particleCloud(mesh);
|
||||||
@ -79,7 +79,7 @@ int main(int argc, char *argv[])
|
|||||||
scalar m(0.0);
|
scalar m(0.0);
|
||||||
scalar m0(0.0);
|
scalar m0(0.0);
|
||||||
label counter(0);
|
label counter(0);
|
||||||
|
|
||||||
while (runTime.run())
|
while (runTime.run())
|
||||||
{
|
{
|
||||||
#include "readTimeControls.H"
|
#include "readTimeControls.H"
|
||||||
@ -87,8 +87,8 @@ int main(int argc, char *argv[])
|
|||||||
#include "setDeltaT.H"
|
#include "setDeltaT.H"
|
||||||
|
|
||||||
runTime++;
|
runTime++;
|
||||||
|
|
||||||
particleCloud.clockM().start(1,"Global");
|
particleCloud.clockM().start(1,"Global");
|
||||||
|
|
||||||
Info<< "Time = " << runTime.timeName() << nl << endl;
|
Info<< "Time = " << runTime.timeName() << nl << endl;
|
||||||
|
|
||||||
@ -100,7 +100,7 @@ int main(int argc, char *argv[])
|
|||||||
{
|
{
|
||||||
particleCloud.smoothingM().smoothen(particleCloud.forceM(0).impParticleForces());
|
particleCloud.smoothingM().smoothen(particleCloud.forceM(0).impParticleForces());
|
||||||
}
|
}
|
||||||
|
|
||||||
Info << "update Ksl.internalField()" << endl;
|
Info << "update Ksl.internalField()" << endl;
|
||||||
Ksl = particleCloud.momCoupleM(0).impMomSource();
|
Ksl = particleCloud.momCoupleM(0).impMomSource();
|
||||||
Ksl.correctBoundaryConditions();
|
Ksl.correctBoundaryConditions();
|
||||||
@ -116,13 +116,13 @@ int main(int argc, char *argv[])
|
|||||||
particleCloud.clockM().stop("Coupling");
|
particleCloud.clockM().stop("Coupling");
|
||||||
|
|
||||||
particleCloud.clockM().start(26,"Flow");
|
particleCloud.clockM().start(26,"Flow");
|
||||||
|
|
||||||
if (pimple.nCorrPIMPLE() <= 1)
|
if (pimple.nCorrPIMPLE() <= 1)
|
||||||
{
|
{
|
||||||
#include "rhoEqn.H"
|
#include "rhoEqn.H"
|
||||||
}
|
}
|
||||||
|
|
||||||
rhoeps = rho * voidfraction;
|
rhoeps = rho * voidfraction;
|
||||||
// --- Pressure-velocity PIMPLE corrector loop
|
// --- Pressure-velocity PIMPLE corrector loop
|
||||||
while (pimple.loop())
|
while (pimple.loop())
|
||||||
{
|
{
|
||||||
@ -133,10 +133,10 @@ int main(int argc, char *argv[])
|
|||||||
// --- Pressure corrector loop
|
// --- Pressure corrector loop
|
||||||
while (pimple.correct())
|
while (pimple.correct())
|
||||||
{
|
{
|
||||||
#include "molConc.H"
|
#include "molConc.H"
|
||||||
#include "pEqn.H"
|
#include "pEqn.H"
|
||||||
}
|
}
|
||||||
|
|
||||||
if (pimple.turbCorr())
|
if (pimple.turbCorr())
|
||||||
{
|
{
|
||||||
turbulence->correct();
|
turbulence->correct();
|
||||||
@ -144,14 +144,14 @@ int main(int argc, char *argv[])
|
|||||||
}
|
}
|
||||||
|
|
||||||
#include "monitorMass.H"
|
#include "monitorMass.H"
|
||||||
|
|
||||||
particleCloud.clockM().start(31,"postFlow");
|
particleCloud.clockM().start(31,"postFlow");
|
||||||
particleCloud.postFlow();
|
particleCloud.postFlow();
|
||||||
particleCloud.clockM().stop("postFlow");
|
particleCloud.clockM().stop("postFlow");
|
||||||
|
|
||||||
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,5 +1,5 @@
|
|||||||
// thermodynamics, chemistry
|
// thermodynamics, chemistry
|
||||||
|
|
||||||
Info<< "Creating combustion model\n" << endl;
|
Info<< "Creating combustion model\n" << endl;
|
||||||
|
|
||||||
autoPtr<combustionModels::rhoCombustionModel> combustion
|
autoPtr<combustionModels::rhoCombustionModel> combustion
|
||||||
@ -73,7 +73,7 @@
|
|||||||
),
|
),
|
||||||
mesh
|
mesh
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "\nReading voidfraction field voidfraction = (Vgas/Vparticle)\n" << endl;
|
Info<< "\nReading voidfraction field voidfraction = (Vgas/Vparticle)\n" << endl;
|
||||||
volScalarField voidfraction
|
volScalarField voidfraction
|
||||||
(
|
(
|
||||||
@ -87,7 +87,7 @@
|
|||||||
),
|
),
|
||||||
mesh
|
mesh
|
||||||
);
|
);
|
||||||
|
|
||||||
volScalarField rhoeps
|
volScalarField rhoeps
|
||||||
(
|
(
|
||||||
IOobject
|
IOobject
|
||||||
@ -115,7 +115,7 @@
|
|||||||
mesh,
|
mesh,
|
||||||
dimensionedScalar("zero", dimensionSet(1,-1,-3,0,0,0,0), 0.0)
|
dimensionedScalar("zero", dimensionSet(1,-1,-3,0,0,0,0), 0.0)
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "\nCreating fluid-particle heat flux coefficient field\n" << endl;
|
Info<< "\nCreating fluid-particle heat flux coefficient field\n" << endl;
|
||||||
volScalarField QCoeff
|
volScalarField QCoeff
|
||||||
(
|
(
|
||||||
@ -130,7 +130,7 @@
|
|||||||
mesh,
|
mesh,
|
||||||
dimensionedScalar("zero", dimensionSet(1,-1,-3,-1,0,0,0), 0.0)
|
dimensionedScalar("zero", dimensionSet(1,-1,-3,-1,0,0,0), 0.0)
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "\nCreating thermal conductivity field\n" << endl;
|
Info<< "\nCreating thermal conductivity field\n" << endl;
|
||||||
volScalarField thCond
|
volScalarField thCond
|
||||||
(
|
(
|
||||||
@ -145,7 +145,7 @@
|
|||||||
mesh,
|
mesh,
|
||||||
dimensionedScalar("zero", dimensionSet(1,1,-3,-1,0,0,0), 0.0)
|
dimensionedScalar("zero", dimensionSet(1,1,-3,-1,0,0,0), 0.0)
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "\nCreating heat capacity field\n" << endl;
|
Info<< "\nCreating heat capacity field\n" << endl;
|
||||||
volScalarField Cpv
|
volScalarField Cpv
|
||||||
(
|
(
|
||||||
@ -224,7 +224,7 @@
|
|||||||
|
|
||||||
Info<< "Creating field kinetic energy K\n" << endl;
|
Info<< "Creating field kinetic energy K\n" << endl;
|
||||||
volScalarField K("K", 0.5*magSqr(U));
|
volScalarField K("K", 0.5*magSqr(U));
|
||||||
|
|
||||||
volScalarField dQ
|
volScalarField dQ
|
||||||
(
|
(
|
||||||
IOobject
|
IOobject
|
||||||
@ -238,7 +238,7 @@
|
|||||||
mesh,
|
mesh,
|
||||||
dimensionedScalar("dQ", dimEnergy/dimTime, 0.0)
|
dimensionedScalar("dQ", dimEnergy/dimTime, 0.0)
|
||||||
);
|
);
|
||||||
|
|
||||||
Info<< "\nReading momentum exchange field Ksl\n" << endl;
|
Info<< "\nReading momentum exchange field Ksl\n" << endl;
|
||||||
volScalarField Ksl
|
volScalarField Ksl
|
||||||
(
|
(
|
||||||
|
|||||||
@ -3,10 +3,10 @@
|
|||||||
forAll(Y, i)
|
forAll(Y, i)
|
||||||
{
|
{
|
||||||
volScalarField& Yi = Y[i];
|
volScalarField& Yi = Y[i];
|
||||||
dimensionedScalar mi("mi",dimensionSet(1, 0, 0, 0, -1),composition.W(i));
|
dimensionedScalar mi("mi",dimensionSet(1, 0, 0, 0, -1),composition.W(i));
|
||||||
mi /= 1000.0; // g to kg
|
mi /= 1000.0; // g to kg
|
||||||
molarConc += rho * Yi / mi;
|
molarConc += rho * Yi / mi;
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
// ************************************************************************* //
|
// ************************************************************************* //
|
||||||
|
|||||||
@ -32,13 +32,13 @@ else
|
|||||||
// + rhorAUf*fvc::ddtCorr(rho, U, phi)
|
// + rhorAUf*fvc::ddtCorr(rho, U, phi)
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
|
|
||||||
// flux without pressure gradient contribution
|
// flux without pressure gradient contribution
|
||||||
phi = phiHbyA + phiUs;
|
phi = phiHbyA + phiUs;
|
||||||
|
|
||||||
// Update the pressure BCs to ensure flux consistency
|
// Update the pressure BCs to ensure flux consistency
|
||||||
constrainPressure(p, rhoeps, U, phi, rhorAUf);
|
constrainPressure(p, rhoeps, U, phi, rhorAUf);
|
||||||
|
|
||||||
volScalarField SmbyP(particleCloud.chemistryM(0).Sm() / p);
|
volScalarField SmbyP(particleCloud.chemistryM(0).Sm() / p);
|
||||||
|
|
||||||
while (pimple.correctNonOrthogonal())
|
while (pimple.correctNonOrthogonal())
|
||||||
|
|||||||
@ -38,7 +38,7 @@ else
|
|||||||
// + rhorAUf*fvc::ddtCorr(rho, U, phi)
|
// + rhorAUf*fvc::ddtCorr(rho, U, phi)
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
|
|
||||||
// flux without pressure gradient contribution
|
// flux without pressure gradient contribution
|
||||||
phi = phiHbyA + phiUs;
|
phi = phiHbyA + phiUs;
|
||||||
|
|
||||||
|
|||||||
@ -15,4 +15,4 @@
|
|||||||
fvOptions.correct(rho);
|
fvOptions.correct(rho);
|
||||||
}
|
}
|
||||||
|
|
||||||
// ************************************************************************* //
|
// ************************************************************************* //
|
||||||
|
|||||||
@ -166,7 +166,7 @@ bool cfdemCloudEnergy::evolve
|
|||||||
if(verbose_) Info << "speciesExecute done" << endl;
|
if(verbose_) Info << "speciesExecute done" << endl;
|
||||||
clockM().stop("speciesExecute");
|
clockM().stop("speciesExecute");
|
||||||
|
|
||||||
return true;
|
return true;
|
||||||
}
|
}
|
||||||
return false;
|
return false;
|
||||||
}
|
}
|
||||||
|
|||||||
@ -61,7 +61,7 @@ protected:
|
|||||||
autoPtr<energyModel>* energyModel_;
|
autoPtr<energyModel>* energyModel_;
|
||||||
|
|
||||||
autoPtr<thermCondModel> thermCondModel_;
|
autoPtr<thermCondModel> thermCondModel_;
|
||||||
|
|
||||||
autoPtr<chemistryModel>* chemistryModel_;
|
autoPtr<chemistryModel>* chemistryModel_;
|
||||||
|
|
||||||
void calcEnergyContributions();
|
void calcEnergyContributions();
|
||||||
@ -93,7 +93,7 @@ public:
|
|||||||
const energyModel& energyM(int);
|
const energyModel& energyM(int);
|
||||||
|
|
||||||
const thermCondModel& thermCondM();
|
const thermCondModel& thermCondM();
|
||||||
|
|
||||||
const chemistryModel& chemistryM(int);
|
const chemistryModel& chemistryM(int);
|
||||||
|
|
||||||
label nrEnergyModels() const;
|
label nrEnergyModels() const;
|
||||||
@ -107,7 +107,7 @@ public:
|
|||||||
inline const wordList& energyModels();
|
inline const wordList& energyModels();
|
||||||
|
|
||||||
inline const wordList& chemistryModels();
|
inline const wordList& chemistryModels();
|
||||||
|
|
||||||
void energyContributions(volScalarField&);
|
void energyContributions(volScalarField&);
|
||||||
|
|
||||||
void energyCoefficients(volScalarField&);
|
void energyCoefficients(volScalarField&);
|
||||||
|
|||||||
@ -175,8 +175,8 @@ public:
|
|||||||
double**const& weight,
|
double**const& weight,
|
||||||
double**const& mask
|
double**const& mask
|
||||||
) const;
|
) const;
|
||||||
|
|
||||||
void setScalarSumCentre
|
void setScalarSumCentre
|
||||||
(
|
(
|
||||||
volScalarField& field,
|
volScalarField& field,
|
||||||
double**& value,
|
double**& value,
|
||||||
|
|||||||
@ -46,7 +46,7 @@ tmp<volScalarField> chemistryModel::Smi(label i) const
|
|||||||
|
|
||||||
tmp<volScalarField> chemistryModel::Sm() const
|
tmp<volScalarField> chemistryModel::Sm() const
|
||||||
{
|
{
|
||||||
FatalError<<"the solver calls for Smi()\n"
|
FatalError<<"the solver calls for Sm()\n"
|
||||||
<<"please activate 'speciesModel' in 'chemistryModels'"
|
<<"please activate 'speciesModel' in 'chemistryModels'"
|
||||||
<<abort(FatalError);
|
<<abort(FatalError);
|
||||||
|
|
||||||
|
|||||||
@ -44,9 +44,9 @@ protected:
|
|||||||
const dictionary& dict_;
|
const dictionary& dict_;
|
||||||
|
|
||||||
cfdemCloudEnergy& particleCloud_;
|
cfdemCloudEnergy& particleCloud_;
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
public:
|
public:
|
||||||
|
|
||||||
//- Runtime type information
|
//- Runtime type information
|
||||||
@ -73,7 +73,7 @@ public:
|
|||||||
chemistryModel
|
chemistryModel
|
||||||
(
|
(
|
||||||
const dictionary& dict,
|
const dictionary& dict,
|
||||||
cfdemCloudEnergy& sm
|
cfdemCloudEnergy& sm
|
||||||
);
|
);
|
||||||
|
|
||||||
|
|
||||||
@ -94,11 +94,11 @@ public:
|
|||||||
|
|
||||||
// Member Functions
|
// Member Functions
|
||||||
|
|
||||||
virtual void execute() = 0;
|
virtual void execute() = 0;
|
||||||
|
|
||||||
virtual tmp<volScalarField> Smi (const label i) const;
|
|
||||||
|
|
||||||
virtual tmp<volScalarField> Sm () const;
|
virtual tmp<volScalarField> Smi(const label i) const;
|
||||||
|
|
||||||
|
virtual tmp<volScalarField> Sm() const;
|
||||||
};
|
};
|
||||||
|
|
||||||
|
|
||||||
|
|||||||
@ -16,7 +16,7 @@ License
|
|||||||
|
|
||||||
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
||||||
M. Efe Kinaci, JKU Linz, Austria
|
M. Efe Kinaci, JKU Linz, Austria
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Model to communicate Sherwood number necessary coefficients
|
Model to communicate Sherwood number necessary coefficients
|
||||||
|
|
||||||
|
|||||||
@ -16,7 +16,7 @@ License
|
|||||||
|
|
||||||
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
||||||
M. Efe Kinaci, JKU Linz, Austria
|
M. Efe Kinaci, JKU Linz, Austria
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Chemistry turned off
|
Chemistry turned off
|
||||||
|
|
||||||
@ -64,7 +64,7 @@ public:
|
|||||||
|
|
||||||
// Member Functions
|
// Member Functions
|
||||||
|
|
||||||
void execute();
|
void execute();
|
||||||
|
|
||||||
};
|
};
|
||||||
|
|
||||||
|
|||||||
@ -15,7 +15,7 @@ License
|
|||||||
along with this code. If not, see <http://www.gnu.org/licenses/>.
|
along with this code. If not, see <http://www.gnu.org/licenses/>.
|
||||||
|
|
||||||
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Model to communicate available reactant per particle
|
Model to communicate available reactant per particle
|
||||||
|
|
||||||
@ -55,17 +55,17 @@ private:
|
|||||||
const fvMesh& mesh_;
|
const fvMesh& mesh_;
|
||||||
|
|
||||||
mutable double **reactantPerParticle_;
|
mutable double **reactantPerParticle_;
|
||||||
|
|
||||||
word voidfractionFieldName_;
|
word voidfractionFieldName_;
|
||||||
|
|
||||||
const volScalarField& voidfraction_;
|
const volScalarField& voidfraction_;
|
||||||
|
|
||||||
mutable volScalarField particlesPerCell_;
|
mutable volScalarField particlesPerCell_;
|
||||||
|
|
||||||
void allocateMyArrays() const;
|
void allocateMyArrays() const;
|
||||||
|
|
||||||
label loopCounter_;
|
label loopCounter_;
|
||||||
|
|
||||||
label Nevery_;
|
label Nevery_;
|
||||||
|
|
||||||
public:
|
public:
|
||||||
|
|||||||
@ -205,7 +205,7 @@ void species::init()
|
|||||||
mesh_,
|
mesh_,
|
||||||
dimensionedScalar("zero",dimMass/(dimVol*dimTime), 0.0)
|
dimensionedScalar("zero",dimMass/(dimVol*dimTime), 0.0)
|
||||||
)
|
)
|
||||||
);
|
);
|
||||||
}
|
}
|
||||||
initialized_ = true;
|
initialized_ = true;
|
||||||
}
|
}
|
||||||
@ -216,9 +216,9 @@ void species::execute()
|
|||||||
{
|
{
|
||||||
if(!initialized_)
|
if(!initialized_)
|
||||||
{
|
{
|
||||||
init();
|
init();
|
||||||
}
|
}
|
||||||
|
|
||||||
loopCounter_++;
|
loopCounter_++;
|
||||||
if (loopCounter_ % Nevery_ != 0)
|
if (loopCounter_ % Nevery_ != 0)
|
||||||
{
|
{
|
||||||
|
|||||||
@ -16,7 +16,7 @@ License
|
|||||||
|
|
||||||
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
Copyright (C) 2015- Thomas Lichtenegger, JKU Linz, Austria
|
||||||
M. Efe Kinaci, JKU Linz, Austria
|
M. Efe Kinaci, JKU Linz, Austria
|
||||||
|
|
||||||
Description
|
Description
|
||||||
Model to communicate species concentration and changes due to reactions
|
Model to communicate species concentration and changes due to reactions
|
||||||
|
|
||||||
@ -56,26 +56,26 @@ private:
|
|||||||
bool interpolation_;
|
bool interpolation_;
|
||||||
|
|
||||||
const fvMesh& mesh_;
|
const fvMesh& mesh_;
|
||||||
|
|
||||||
bool verbose_;
|
bool verbose_;
|
||||||
|
|
||||||
// Species dictionary - To be read where the species are from
|
// Species dictionary - To be read where the species are from
|
||||||
dictionary specDict_;
|
dictionary specDict_;
|
||||||
|
|
||||||
wordList speciesNames_;
|
wordList speciesNames_;
|
||||||
|
|
||||||
wordList mod_spec_names_;
|
wordList mod_spec_names_;
|
||||||
|
|
||||||
UPtrList<volScalarField> X_;
|
UPtrList<volScalarField> X_;
|
||||||
|
|
||||||
mutable List<double**> molarFractions_;
|
mutable List<double**> molarFractions_;
|
||||||
|
|
||||||
mutable List<double**> changeOfSpeciesMass_;
|
mutable List<double**> changeOfSpeciesMass_;
|
||||||
|
|
||||||
PtrList<volScalarField> changeOfSpeciesMassFields_;
|
PtrList<volScalarField> changeOfSpeciesMassFields_;
|
||||||
|
|
||||||
volScalarField changeOfGasMassField_;
|
volScalarField changeOfGasMassField_;
|
||||||
|
|
||||||
word tempFieldName_;
|
word tempFieldName_;
|
||||||
|
|
||||||
const volScalarField& tempField_; // ref to gas temperature field
|
const volScalarField& tempField_; // ref to gas temperature field
|
||||||
@ -89,7 +89,7 @@ private:
|
|||||||
const volScalarField& rho_;
|
const volScalarField& rho_;
|
||||||
|
|
||||||
word partRhoName_;
|
word partRhoName_;
|
||||||
|
|
||||||
mutable double **partRho_; // gas density at particle positions
|
mutable double **partRho_; // gas density at particle positions
|
||||||
|
|
||||||
word voidfractionFieldName_;
|
word voidfractionFieldName_;
|
||||||
@ -106,17 +106,17 @@ private:
|
|||||||
word partMolarConcName_;
|
word partMolarConcName_;
|
||||||
|
|
||||||
mutable double **partMolarConc_;
|
mutable double **partMolarConc_;
|
||||||
|
|
||||||
label loopCounter_;
|
label loopCounter_;
|
||||||
|
|
||||||
label Nevery_;
|
label Nevery_;
|
||||||
|
|
||||||
scalar massSourceCurr_;
|
scalar massSourceCurr_;
|
||||||
|
|
||||||
scalar massSourceTot_;
|
scalar massSourceTot_;
|
||||||
|
|
||||||
bool initialized_;
|
bool initialized_;
|
||||||
|
|
||||||
void init();
|
void init();
|
||||||
|
|
||||||
public:
|
public:
|
||||||
|
|||||||
Reference in New Issue
Block a user