From acfeb17237786ccc9329076f90d4bd82277347c5 Mon Sep 17 00:00:00 2001 From: henry Date: Mon, 17 May 2010 15:16:52 +0100 Subject: [PATCH 1/5] turbulenceModel: Added `rheEpsilonEff' Provides the viscous contribution to the energy equations. --- .../compressible/turbulenceModel/turbulenceModel.C | 8 ++++++++ .../compressible/turbulenceModel/turbulenceModel.H | 4 ++++ 2 files changed, 12 insertions(+) diff --git a/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.C b/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.C index 5c936fa28e..19f31068bf 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.C +++ b/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.C @@ -26,6 +26,7 @@ License #include "turbulenceModel.H" #include "volFields.H" #include "surfaceFields.H" +#include "fvcGrad.H" // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -115,6 +116,13 @@ autoPtr turbulenceModel::New // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // +tmp turbulenceModel::rhoEpsilonEff() const +{ + tmp tgradU = fvc::grad(U_); + return mu()*(tgradU() && dev(twoSymm(tgradU()))) + rho_*epsilon(); +} + + void turbulenceModel::correct() {} diff --git a/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.H b/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.H index c79cc5dc10..420b24f680 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.H +++ b/src/turbulenceModels/compressible/turbulenceModel/turbulenceModel.H @@ -206,6 +206,10 @@ public: //- Return the turbulence kinetic energy dissipation rate virtual tmp epsilon() const = 0; + //- Return the laminar+turbulence kinetic energy dissipation rate + // Used as the viscous contribution to the energy equations + virtual tmp rhoEpsilonEff() const; + //- Return the Reynolds stress tensor virtual tmp R() const = 0; From 052ef89a17adf42edd45bd3d96d755553ccc22bb Mon Sep 17 00:00:00 2001 From: mattijs Date: Mon, 17 May 2010 15:49:31 +0100 Subject: [PATCH 2/5] BUG: TimeActivatedExplicitSource : active switch not parsed correctly --- .../timeActivatedExplicitSource/TimeActivatedExplicitSource.C | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/finiteVolume/cfdTools/general/fieldSources/timeActivatedExplicitSource/TimeActivatedExplicitSource.C b/src/finiteVolume/cfdTools/general/fieldSources/timeActivatedExplicitSource/TimeActivatedExplicitSource.C index 1873bbe3fe..f5a768c4a8 100644 --- a/src/finiteVolume/cfdTools/general/fieldSources/timeActivatedExplicitSource/TimeActivatedExplicitSource.C +++ b/src/finiteVolume/cfdTools/general/fieldSources/timeActivatedExplicitSource/TimeActivatedExplicitSource.C @@ -326,7 +326,7 @@ Foam::TimeActivatedExplicitSource::TimeActivatedExplicitSource : name_(name), mesh_(mesh), - active_(dict.lookup("active")), + active_(readBool(dict.lookup("active"))), timeStart_(readScalar(dict.lookup("timeStart"))), duration_(readScalar(dict.lookup("duration"))), volumeMode_(wordToVolumeModeType(dict.lookup("volumeMode"))), From 1c5a97458d17c3a19e291a7eae9c820ef9086ef9 Mon Sep 17 00:00:00 2001 From: mattijs Date: Mon, 17 May 2010 15:49:47 +0100 Subject: [PATCH 3/5] STYLE: turbulentTemperatureCoupledBaffleMixed : renamed alpha to alpaEff --- ...turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C index bb3ce48d3a..c58c5f162a 100644 --- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C +++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C @@ -151,13 +151,11 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::K() const const compressible::RASModel& model = db().lookupObject("RASProperties"); - tmp talpha = model.alphaEff(); - const basicThermo& thermo = db().lookupObject("thermophysicalProperties"); return - talpha().boundaryField()[patch().index()] + model.alphaEff()().boundaryField()[patch().index()] *thermo.Cp()().boundaryField()[patch().index()]; } else if (mesh.objectRegistry::foundObject(KName_)) From e757cbd004e86df0cc75bc44155ac5ec74be0d0c Mon Sep 17 00:00:00 2001 From: sergio Date: Mon, 17 May 2010 17:17:32 +0100 Subject: [PATCH 4/5] ENH: swirlMassFlowRateInletVelocity inlet BC --- src/finiteVolume/Make/files | 1 + ...sFlowRateInletVelocityFvPatchVectorField.C | 200 ++++++++++++++++++ ...sFlowRateInletVelocityFvPatchVectorField.H | 191 +++++++++++++++++ 3 files changed, 392 insertions(+) create mode 100644 src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.C create mode 100644 src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.H diff --git a/src/finiteVolume/Make/files b/src/finiteVolume/Make/files index 0fc8dbf70c..2d1b6effb0 100644 --- a/src/finiteVolume/Make/files +++ b/src/finiteVolume/Make/files @@ -150,6 +150,7 @@ $(derivedFvPatchFields)/turbulentIntensityKineticEnergyInlet/turbulentIntensityK $(derivedFvPatchFields)/uniformFixedValue/uniformFixedValueFvPatchFields.C $(derivedFvPatchFields)/waveTransmissive/waveTransmissiveFvPatchFields.C $(derivedFvPatchFields)/uniformDensityHydrostaticPressure/uniformDensityHydrostaticPressureFvPatchScalarField.C +$(derivedFvPatchFields)/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.C fvsPatchFields = fields/fvsPatchFields $(fvsPatchFields)/fvsPatchField/fvsPatchFields.C diff --git a/src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.C new file mode 100644 index 0000000000..c08dbde495 --- /dev/null +++ b/src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.C @@ -0,0 +1,200 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2006-2009 OpenCFD Ltd. + \\/ M anipulation | +------------------------------------------------------------------------------- +License + This file is part of OpenFOAM. + + OpenFOAM is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the + Free Software Foundation; either version 2 of the License, or (at your + option) any later version. + + OpenFOAM is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License + for more details. + + You should have received a copy of the GNU General Public License + along with OpenFOAM; if not, write to the Free Software Foundation, + Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA + +\*---------------------------------------------------------------------------*/ + +#include "swirlMassFlowRateInletVelocityFvPatchVectorField.H" +#include "volFields.H" +#include "addToRunTimeSelectionTable.H" +#include "fvPatchFieldMapper.H" +#include "surfaceFields.H" +#include "mathematicalConstants.H" + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam:: +swirlMassFlowRateInletVelocityFvPatchVectorField:: +swirlMassFlowRateInletVelocityFvPatchVectorField +( + const fvPatch& p, + const DimensionedField& iF +) +: + fixedValueFvPatchField(p, iF), + flowRate_(0), + phiName_("phi"), + rhoName_("rho"), + rpm_(0) +{} + + +Foam:: +swirlMassFlowRateInletVelocityFvPatchVectorField:: +swirlMassFlowRateInletVelocityFvPatchVectorField +( + const swirlMassFlowRateInletVelocityFvPatchVectorField& ptf, + const fvPatch& p, + const DimensionedField& iF, + const fvPatchFieldMapper& mapper +) +: + fixedValueFvPatchField(ptf, p, iF, mapper), + flowRate_(ptf.flowRate_), + phiName_(ptf.phiName_), + rhoName_(ptf.rhoName_) +{} + + +Foam:: +swirlMassFlowRateInletVelocityFvPatchVectorField:: +swirlMassFlowRateInletVelocityFvPatchVectorField +( + const fvPatch& p, + const DimensionedField& iF, + const dictionary& dict +) +: + fixedValueFvPatchField(p, iF, dict), + flowRate_(readScalar(dict.lookup("flowRate"))), + phiName_(dict.lookupOrDefault("phi", "phi")), + rhoName_(dict.lookupOrDefault("rho", "rho")), + rpm_(readScalar(dict.lookup("rpm"))) +{} + + +Foam:: +swirlMassFlowRateInletVelocityFvPatchVectorField:: +swirlMassFlowRateInletVelocityFvPatchVectorField +( + const swirlMassFlowRateInletVelocityFvPatchVectorField& ptf +) +: + fixedValueFvPatchField(ptf), + flowRate_(ptf.flowRate_), + phiName_(ptf.phiName_), + rhoName_(ptf.rhoName_), + rpm_(ptf.rpm_) +{} + + +Foam:: +swirlMassFlowRateInletVelocityFvPatchVectorField:: +swirlMassFlowRateInletVelocityFvPatchVectorField +( + const swirlMassFlowRateInletVelocityFvPatchVectorField& ptf, + const DimensionedField& iF +) +: + fixedValueFvPatchField(ptf, iF), + flowRate_(ptf.flowRate_), + phiName_(ptf.phiName_), + rhoName_(ptf.rhoName_), + rpm_(ptf.rpm_) +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +void Foam::swirlMassFlowRateInletVelocityFvPatchVectorField::updateCoeffs() +{ + if (updated()) + { + return; + } + + scalar totArea = gSum(patch().magSf()); + // a simpler way of doing this would be nice + scalar avgU = -flowRate_/totArea; + + vector center = gSum(patch().Cf()*patch().magSf())/totArea; + vector normal = gSum(patch().nf()*patch().magSf())/totArea; + + vectorField tangVelo = + (rpm_*constant::mathematical::pi/30.0) + *(patch().Cf() - center) ^ normal; + + vectorField n = patch().nf(); + + const surfaceScalarField& phi = + db().lookupObject(phiName_); + + if (phi.dimensions() == dimVelocity*dimArea) + { + // volumetric flow-rate + operator==(tangVelo + n*avgU); + } + else if (phi.dimensions() == dimDensity*dimVelocity*dimArea) + { + const fvPatchField& rhop = + patch().lookupPatchField(rhoName_); + + // mass flow-rate + operator==(tangVelo + n*avgU/rhop); + } + else + { + FatalErrorIn + ( + "swirlMassFlowRateInletVelocityFvPatchVectorField::updateCoeffs()" + ) << "dimensions of " << phiName_ << " are incorrect" << nl + << " on patch " << this->patch().name() + << " of field " << this->dimensionedInternalField().name() + << " in file " << this->dimensionedInternalField().objectPath() + << nl << exit(FatalError); + } + + fixedValueFvPatchField::updateCoeffs(); +} + + +void Foam::swirlMassFlowRateInletVelocityFvPatchVectorField::write(Ostream& os) const +{ + fvPatchField::write(os); + os.writeKeyword("flowRate") << flowRate_ << token::END_STATEMENT << nl; + if (phiName_ != "phi") + { + os.writeKeyword("phi") << phiName_ << token::END_STATEMENT << nl; + } + if (rhoName_ != "rho") + { + os.writeKeyword("rho") << rhoName_ << token::END_STATEMENT << nl; + } + os.writeKeyword("rpm") << rpm_ << token::END_STATEMENT << nl; + writeEntry("value", os); +} + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + makePatchTypeField + ( + fvPatchVectorField, + swirlMassFlowRateInletVelocityFvPatchVectorField + ); +} + + +// ************************************************************************* // diff --git a/src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.H b/src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.H new file mode 100644 index 0000000000..bef41d4655 --- /dev/null +++ b/src/finiteVolume/fields/fvPatchFields/derived/swirlMassFlowRateInletVelocity/swirlMassFlowRateInletVelocityFvPatchVectorField.H @@ -0,0 +1,191 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2010-2010 OpenCFD Ltd. + \\/ M anipulation | +------------------------------------------------------------------------------- +License + This file is part of OpenFOAM. + + OpenFOAM is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the + Free Software Foundation; either version 2 of the License, or (at your + option) any later version. + + OpenFOAM is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License + for more details. + + You should have received a copy of the GNU General Public License + along with OpenFOAM; if not, write to the Free Software Foundation, + Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA + +Class + Foam::swirlMassFlowRateInletVelocityFvPatchVectorField + +Description + Describes a volumetric/mass flow normal vector boundary condition by its + magnitude as an integral over its area with a swirl component determined + by the RPM + + The basis of the patch (volumetric or mass) is determined by the + dimensions of the flux, phi. + The current density is used to correct the velocity when applying the + mass basis. + + Example of the boundary condition specification: + @verbatim + inlet + { + type swirlMassFlowRateInletVelocity; + flowRate 0.2; // Volumetric/mass flow rate [m3/s or kg/s] + rpm 100; + } + @endverbatim + +Note + - The value is positive inwards + +SourceFiles + swirlMassFlowRateInletVelocityFvPatchVectorField.C + +\*---------------------------------------------------------------------------*/ + +#ifndef swirlMassFlowRateInletVelocityFvPatchVectorField_H +#define swirlMassFlowRateInletVelocityFvPatchVectorField_H + +#include "fixedValueFvPatchFields.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ +/*---------------------------------------------------------------------------*\ + Class swirlMassFlowRateInletVelocityFvPatchVectorField Declaration +\*---------------------------------------------------------------------------*/ + +class swirlMassFlowRateInletVelocityFvPatchVectorField +: + public fixedValueFvPatchVectorField +{ + // Private data + + //- Inlet integral flow rate + scalar flowRate_; + + //- Name of the flux transporting the field + word phiName_; + + //- Name of the density field used to normalize the mass flux + word rhoName_; + + //- RPM + scalar rpm_; + + +public: + + //- Runtime type information + TypeName("swirlMassFlowRateInletVelocity"); + + + // Constructors + + //- Construct from patch and internal field + swirlMassFlowRateInletVelocityFvPatchVectorField + ( + const fvPatch&, + const DimensionedField& + ); + + //- Construct from patch, internal field and dictionary + swirlMassFlowRateInletVelocityFvPatchVectorField + ( + const fvPatch&, + const DimensionedField&, + const dictionary& + ); + + //- Construct by mapping given + // flowRateInletVelocityFvPatchVectorField + // onto a new patch + swirlMassFlowRateInletVelocityFvPatchVectorField + ( + const swirlMassFlowRateInletVelocityFvPatchVectorField&, + const fvPatch&, + const DimensionedField&, + const fvPatchFieldMapper& + ); + + //- Construct as copy + swirlMassFlowRateInletVelocityFvPatchVectorField + ( + const swirlMassFlowRateInletVelocityFvPatchVectorField& + ); + + //- Construct and return a clone + virtual tmp clone() const + { + return tmp + ( + new swirlMassFlowRateInletVelocityFvPatchVectorField(*this) + ); + } + + //- Construct as copy setting internal field reference + swirlMassFlowRateInletVelocityFvPatchVectorField + ( + const swirlMassFlowRateInletVelocityFvPatchVectorField&, + const DimensionedField& + ); + + //- Construct and return a clone setting internal field reference + virtual tmp clone + ( + const DimensionedField& iF + ) const + { + return tmp + ( + new swirlMassFlowRateInletVelocityFvPatchVectorField(*this, iF) + ); + } + + + // Member functions + + // Access + + //- Return the flux + scalar flowRate() const + { + return flowRate_; + } + + //- Return reference to the flux to allow adjustment + scalar& flowRate() + { + return flowRate_; + } + + + //- Update the coefficients associated with the patch field + virtual void updateCoeffs(); + + //- Write + virtual void write(Ostream&) const; + +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // From 76afade78890039567a4e04dbb4438bf78489bec Mon Sep 17 00:00:00 2001 From: graham Date: Tue, 18 May 2010 10:30:49 +0100 Subject: [PATCH 5/5] ENH: Correcting pbNumber, shouldn't be divided by number of parcels. Adding pbFixed so nParticles is specified directly by the user, making massTotal not determine anything in this case. Removing unused private data member. --- .../KinematicParcel/KinematicParcel.C | 2 +- .../InjectionModel/InjectionModel.C | 22 +++++++++++++++++-- .../InjectionModel/InjectionModel.H | 7 +++++- .../ManualInjection/ManualInjection.H | 3 --- 4 files changed, 27 insertions(+), 7 deletions(-) diff --git a/src/lagrangian/intermediate/parcels/Templates/KinematicParcel/KinematicParcel.C b/src/lagrangian/intermediate/parcels/Templates/KinematicParcel/KinematicParcel.C index 4d89dedde1..31c274ea38 100644 --- a/src/lagrangian/intermediate/parcels/Templates/KinematicParcel/KinematicParcel.C +++ b/src/lagrangian/intermediate/parcels/Templates/KinematicParcel/KinematicParcel.C @@ -346,7 +346,7 @@ bool Foam::KinematicParcel::hitPatch { ParcelType& p = static_cast(*this); - // Invoke poost-processing mdoel + // Invoke post-processing model td.cloud().postProcessing().postPatch(p, patchI); // Invoke surface film model diff --git a/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.C b/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.C index 84d959976d..a232a5f060 100644 --- a/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.C +++ b/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.C @@ -212,7 +212,12 @@ Foam::scalar Foam::InjectionModel::setNumberOfParticles } case pbNumber: { - nP = massTotal_/(rho*volumeTotal_*parcels); + nP = massTotal_/(rho*volumeTotal_); + break; + } + case pbFixed: + { + nP = nParticlesFixed_; break; } default: @@ -285,6 +290,7 @@ Foam::InjectionModel::InjectionModel(CloudType& owner) nInjections_(0), parcelsAddedTotal_(0), parcelBasis_(pbNumber), + nParticlesFixed_(0.0), time0_(0.0), timeStep0_(0.0) { @@ -310,6 +316,7 @@ Foam::InjectionModel::InjectionModel nInjections_(0), parcelsAddedTotal_(0), parcelBasis_(pbNumber), + nParticlesFixed_(0.0), time0_(owner.db().time().value()), timeStep0_(0.0) { @@ -320,6 +327,7 @@ Foam::InjectionModel::InjectionModel << endl; const word parcelBasisType = coeffDict_.lookup("parcelBasisType"); + if (parcelBasisType == "mass") { parcelBasis_ = pbMass; @@ -328,6 +336,16 @@ Foam::InjectionModel::InjectionModel { parcelBasis_ = pbNumber; } + else if (parcelBasisType == "fixed") + { + parcelBasis_ = pbFixed; + + Info<< " Choosing nParticles to be a fixed value, massTotal " + << "variable now does not determine anything." + << endl; + + nParticlesFixed_ = readScalar(coeffDict_.lookup("nParticles")); + } else { FatalErrorIn @@ -338,7 +356,7 @@ Foam::InjectionModel::InjectionModel "CloudType&, " "const word&" ")" - )<< "parcelBasisType must be either 'number' or 'mass'" << nl + )<< "parcelBasisType must be either 'number', 'mass' or 'fixed'" << nl << exit(FatalError); } diff --git a/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.H b/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.H index d7309f5a0a..c6fb6e424b 100644 --- a/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.H +++ b/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/InjectionModel/InjectionModel.H @@ -73,7 +73,8 @@ public: enum parcelBasis { pbNumber, - pbMass + pbMass, + pbFixed }; @@ -137,6 +138,10 @@ protected: //- Parcel basis enumeration parcelBasis parcelBasis_; + //- nParticles to assign to parcels when the 'fixed' basis + // is selected + scalar nParticlesFixed_; + //- Continuous phase time at start of injection time step [s] scalar time0_; diff --git a/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/ManualInjection/ManualInjection.H b/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/ManualInjection/ManualInjection.H index 7d8305088f..0202c9eb60 100644 --- a/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/ManualInjection/ManualInjection.H +++ b/src/lagrangian/intermediate/submodels/Kinematic/InjectionModel/ManualInjection/ManualInjection.H @@ -76,9 +76,6 @@ class ManualInjection //- Parcel size PDF model const autoPtr parcelPDF_; - //- Number of particles represented by each parcel - scalar nParticlesPerParcel_; - protected: