diff --git a/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C b/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C index e5a9f2094e911d4f34b5032336a9d3fecaf7f988..d318bd73845ced940b24c9f8cf0846cc915b3472 100644 --- a/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C +++ b/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -31,7 +31,7 @@ Description Each view factor between the agglomerated faces i and j (Fij) is calculated using a double integral of the sub-areas composing the agglomaration. - The patches involved in the view factor calculation are taken from the Qr + The patches involved in the view factor calculation are taken from the qr volScalarField (radiative flux) when is greyDiffusiveRadiationViewFactor otherwise they are not included. @@ -272,11 +272,11 @@ int main(int argc, char *argv[]) const label debug = viewFactorDict.lookupOrDefault<label>("debug", 0); - volScalarField Qr + volScalarField qr ( IOobject ( - "Qr", + "qr", runTime.timeName(), mesh, IOobject::MUST_READ, @@ -338,17 +338,17 @@ int main(int argc, char *argv[]) labelList viewFactorsPatches(patches.size()); - const volScalarField::Boundary& Qrb = Qr.boundaryField(); + const volScalarField::Boundary& qrb = qr.boundaryField(); label count = 0; - forAll(Qrb, patchi) + forAll(qrb, patchi) { const polyPatch& pp = patches[patchi]; - const fvPatchScalarField& QrpI = Qrb[patchi]; + const fvPatchScalarField& qrpI = qrb[patchi]; - if ((isA<fixedValueFvPatchScalarField>(QrpI)) && (pp.size() > 0)) + if ((isA<fixedValueFvPatchScalarField>(qrpI)) && (pp.size() > 0)) { - viewFactorsPatches[count] = QrpI.patch().index(); + viewFactorsPatches[count] = qrpI.patch().index(); nCoarseFaces += coarsePatches[patchi].size(); nFineFaces += patches[patchi].size(); count ++; diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.C b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.C index 71c695e80de410e9e1d6ef6a9405a6f7040ae6e8..6ed6e4f72afb060258182e8c36403d934863d02a 100644 --- a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.C +++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -53,9 +53,9 @@ thermalBaffle1DFvPatchScalarField Qs_(p.size()), solidDict_(), solidPtr_(nullptr), - QrPrevious_(p.size()), - QrRelaxation_(1), - QrName_("undefined-Qr") + qrPrevious_(p.size()), + qrRelaxation_(1), + qrName_("undefined-qr") {} @@ -77,9 +77,9 @@ thermalBaffle1DFvPatchScalarField Qs_(ptf.Qs_, mapper), solidDict_(ptf.solidDict_), solidPtr_(ptf.solidPtr_), - QrPrevious_(ptf.QrPrevious_, mapper), - QrRelaxation_(ptf.QrRelaxation_), - QrName_(ptf.QrName_) + qrPrevious_(ptf.qrPrevious_, mapper), + qrRelaxation_(ptf.qrRelaxation_), + qrName_(ptf.qrName_) {} @@ -100,9 +100,9 @@ thermalBaffle1DFvPatchScalarField Qs_(p.size(), 0), solidDict_(dict), solidPtr_(), - QrPrevious_(p.size(), 0.0), - QrRelaxation_(dict.lookupOrDefault<scalar>("relaxation", 1)), - QrName_(dict.lookupOrDefault<word>("Qr", "none")) + qrPrevious_(p.size(), 0.0), + qrRelaxation_(dict.lookupOrDefault<scalar>("relaxation", 1)), + qrName_(dict.lookupOrDefault<word>("qr", "none")) { fvPatchScalarField::operator=(scalarField("value", dict, p.size())); @@ -116,9 +116,9 @@ thermalBaffle1DFvPatchScalarField Qs_ = scalarField("Qs", dict, p.size()); } - if (dict.found("QrPrevious")) + if (dict.found("qrPrevious")) { - QrPrevious_ = scalarField("QrPrevious", dict, p.size()); + qrPrevious_ = scalarField("qrPrevious", dict, p.size()); } if (dict.found("refValue") && baffleActivated_) @@ -154,9 +154,9 @@ thermalBaffle1DFvPatchScalarField Qs_(ptf.Qs_), solidDict_(ptf.solidDict_), solidPtr_(ptf.solidPtr_), - QrPrevious_(ptf.QrPrevious_), - QrRelaxation_(ptf.QrRelaxation_), - QrName_(ptf.QrName_) + qrPrevious_(ptf.qrPrevious_), + qrRelaxation_(ptf.qrRelaxation_), + qrName_(ptf.qrName_) {} @@ -176,9 +176,9 @@ thermalBaffle1DFvPatchScalarField Qs_(ptf.Qs_), solidDict_(ptf.solidDict_), solidPtr_(ptf.solidPtr_), - QrPrevious_(ptf.QrPrevious_), - QrRelaxation_(ptf.QrRelaxation_), - QrName_(ptf.QrName_) + qrPrevious_(ptf.qrPrevious_), + qrRelaxation_(ptf.qrRelaxation_), + qrName_(ptf.qrName_) {} @@ -364,15 +364,15 @@ void thermalBaffle1DFvPatchScalarField<solidType>::updateCoeffs() patch().template lookupPatchField<volScalarField, scalar>(TName_); - scalarField Qr(Tp.size(), 0.0); + scalarField qr(Tp.size(), 0.0); - if (QrName_ != "none") + if (qrName_ != "none") { - Qr = patch().template lookupPatchField<volScalarField, scalar> - (QrName_); + qr = patch().template lookupPatchField<volScalarField, scalar> + (qrName_); - Qr = QrRelaxation_*Qr + (1.0 - QrRelaxation_)*QrPrevious_; - QrPrevious_ = Qr; + qr = qrRelaxation_*qr + (1.0 - qrRelaxation_)*qrPrevious_; + qrPrevious_ = qr; } tmp<scalarField> Ti = patchInternalField(); @@ -393,7 +393,7 @@ void thermalBaffle1DFvPatchScalarField<solidType>::updateCoeffs() scalarField KDeltaSolid(kappas/baffleThickness()); - scalarField alpha(KDeltaSolid - Qr/Tp); + scalarField alpha(KDeltaSolid - qr/Tp); valueFraction() = alpha/(alpha + myKDelta); @@ -435,9 +435,9 @@ void thermalBaffle1DFvPatchScalarField<solidType>::write(Ostream& os) const solid().write(os); } - QrPrevious_.writeEntry("QrPrevious", os); - os.writeKeyword("Qr")<< QrName_ << token::END_STATEMENT << nl; - os.writeKeyword("relaxation")<< QrRelaxation_ + qrPrevious_.writeEntry("qrPrevious", os); + os.writeKeyword("qr")<< qrName_ << token::END_STATEMENT << nl; + os.writeKeyword("relaxation")<< qrRelaxation_ << token::END_STATEMENT << nl; } diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H index af6c701bc76c186a1030714b3137edf112f6fa12..f9491806fecfdde79494d021c10b96b524745e30 100644 --- a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H +++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H @@ -31,8 +31,8 @@ Description This BC solves a steady 1D thermal baffle. The solid properties are specify as dictionary. Optionaly radiative heat - flux (Qr) can be incorporated into the balance. Some under-relaxation might - be needed on Qr. Baffle and solid properties need to be specified on the + flux (qr) can be incorporated into the balance. Some under-relaxation might + be needed on qr. Baffle and solid properties need to be specified on the master side of the baffle. Usage @@ -48,7 +48,7 @@ Usage thickness uniform 0.005; // thickness [m] Qs uniform 100; // heat flux [W/m2] - Qr none; + qr none; relaxation 1; // Solid thermo @@ -78,7 +78,7 @@ Usage type compressible::thermalBaffle1D<hConstSolidThermoPhysics>; samplePatch <masterPatchName>; - Qr none; + qr none; relaxation 1; } \endverbatim @@ -132,14 +132,14 @@ class thermalBaffle1DFvPatchScalarField //- Solid thermo mutable autoPtr<solidType> solidPtr_; - //- Cache Qr for relaxation - scalarField QrPrevious_; + //- Cache qr for relaxation + scalarField qrPrevious_; - //- Relaxation for Qr - scalar QrRelaxation_; + //- Relaxation for qr + scalar qrRelaxation_; //- Name of the radiative heat flux in local region - const word QrName_; + const word qrName_; // Private members diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C index d69c96ee2c8e92989daa7f93ab8d5d710d067240..d238c6fc9036ab177a6ea7b982da4f577fae7ebc 100644 --- a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C +++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -48,8 +48,8 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField mixedFvPatchScalarField(p, iF), temperatureCoupledBase(patch(), "undefined", "undefined", "undefined-K"), TnbrName_("undefined-Tnbr"), - QrNbrName_("undefined-QrNbr"), - QrName_("undefined-Qr"), + qrNbrName_("undefined-qrNbr"), + qrName_("undefined-qr"), thicknessLayers_(0), kappaLayers_(0), contactRes_(0) @@ -72,8 +72,8 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField mixedFvPatchScalarField(psf, p, iF, mapper), temperatureCoupledBase(patch(), psf), TnbrName_(psf.TnbrName_), - QrNbrName_(psf.QrNbrName_), - QrName_(psf.QrName_), + qrNbrName_(psf.qrNbrName_), + qrName_(psf.qrName_), thicknessLayers_(psf.thicknessLayers_), kappaLayers_(psf.kappaLayers_), contactRes_(psf.contactRes_) @@ -91,8 +91,8 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField mixedFvPatchScalarField(p, iF), temperatureCoupledBase(patch(), dict), TnbrName_(dict.lookupOrDefault<word>("Tnbr", "T")), - QrNbrName_(dict.lookupOrDefault<word>("QrNbr", "none")), - QrName_(dict.lookupOrDefault<word>("Qr", "none")), + qrNbrName_(dict.lookupOrDefault<word>("qrNbr", "none")), + qrName_(dict.lookupOrDefault<word>("qr", "none")), thicknessLayers_(0), kappaLayers_(0), contactRes_(0.0) @@ -152,8 +152,8 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField mixedFvPatchScalarField(psf, iF), temperatureCoupledBase(patch(), psf), TnbrName_(psf.TnbrName_), - QrNbrName_(psf.QrNbrName_), - QrName_(psf.QrName_), + qrNbrName_(psf.qrNbrName_), + qrName_(psf.qrName_), thicknessLayers_(psf.thicknessLayers_), kappaLayers_(psf.kappaLayers_), contactRes_(psf.contactRes_) @@ -212,22 +212,22 @@ void turbulentTemperatureRadCoupledMixedFvPatchScalarField::updateCoeffs() scalarField KDelta(kappa(Tp)*patch().deltaCoeffs()); - scalarField Qr(Tp.size(), 0.0); - if (QrName_ != "none") + scalarField qr(Tp.size(), 0.0); + if (qrName_ != "none") { - Qr = patch().lookupPatchField<volScalarField, scalar>(QrName_); + qr = patch().lookupPatchField<volScalarField, scalar>(qrName_); } - scalarField QrNbr(Tp.size(), 0.0); - if (QrNbrName_ != "none") + scalarField qrNbr(Tp.size(), 0.0); + if (qrNbrName_ != "none") { - QrNbr = nbrPatch.lookupPatchField<volScalarField, scalar>(QrNbrName_); - mpp.distribute(QrNbr); + qrNbr = nbrPatch.lookupPatchField<volScalarField, scalar>(qrNbrName_); + mpp.distribute(qrNbr); } valueFraction() = KDeltaNbr/(KDeltaNbr + KDelta); refValue() = TcNbr; - refGrad() = (Qr + QrNbr)/kappa(Tp); + refGrad() = (qr + qrNbr)/kappa(Tp); mixedFvPatchScalarField::updateCoeffs(); @@ -261,8 +261,8 @@ void turbulentTemperatureRadCoupledMixedFvPatchScalarField::write { mixedFvPatchScalarField::write(os); os.writeKeyword("Tnbr")<< TnbrName_ << token::END_STATEMENT << nl; - os.writeKeyword("QrNbr")<< QrNbrName_ << token::END_STATEMENT << nl; - os.writeKeyword("Qr")<< QrName_ << token::END_STATEMENT << nl; + os.writeKeyword("qrNbr")<< qrNbrName_ << token::END_STATEMENT << nl; + os.writeKeyword("qr")<< qrName_ << token::END_STATEMENT << nl; thicknessLayers_.writeEntry("thicknessLayers", os); kappaLayers_.writeEntry("kappaLayers", os); diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H index 275362096544acfca545d5a7ba1100dc49f338de..37691d22d3e94bb751ff2890c0904809c9602c93 100644 --- a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H +++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -38,8 +38,8 @@ Usage \table Property | Description | Required | Default value Tnbr | name of the field | no | T - QrNbr | name of the radiative flux in the nbr region | no | none - Qr | name of the radiative flux in this region | no | none + qrNbr | name of the radiative flux in the nbr region | no | none + qr | name of the radiative flux in this region | no | none thicknessLayers | list of thicknesses per layer [m] | no | kappaLayers | list of thermal conductivites per layer [W/m/K] | no | kappaMethod | inherited from temperatureCoupledBase | inherited | @@ -52,8 +52,8 @@ Usage { type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; - QrNbr Qr; // or none. Name of Qr field on neighbour region - Qr Qr; // or none. Name of Qr field on local region + qrNbr qr; // or none. Name of qr field on neighbour region + qr qr; // or none. Name of qr field on local region thicknessLayers (0.1 0.2 0.3 0.4); kappaLayers (1 2 3 4); kappaMethod lookup; @@ -101,10 +101,10 @@ class turbulentTemperatureRadCoupledMixedFvPatchScalarField const word TnbrName_; //- Name of the radiative heat flux in the neighbout region - const word QrNbrName_; + const word qrNbrName_; //- Name of the radiative heat flux in local region - const word QrName_; + const word qrName_; //- Thickness of layers scalarList thicknessLayers_; diff --git a/src/functionObjects/field/wallHeatFlux/wallHeatFlux.C b/src/functionObjects/field/wallHeatFlux/wallHeatFlux.C index 67dfc57bff12ff370ac50287c52ff368cdbfe60e..2c7531fc8800dd13a783a4f7a7a1dd63d0f291f2 100644 --- a/src/functionObjects/field/wallHeatFlux/wallHeatFlux.C +++ b/src/functionObjects/field/wallHeatFlux/wallHeatFlux.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2016-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -78,12 +78,12 @@ void Foam::functionObjects::wallHeatFlux::calcHeatFlux wallHeatFluxBf[patchi] = heatFluxBf[patchi]; } - if (foundObject<volScalarField>("Qr")) + if (foundObject<volScalarField>("qr")) { - const volScalarField& Qr = lookupObject<volScalarField>("Qr"); + const volScalarField& qr = lookupObject<volScalarField>("qr"); const volScalarField::Boundary& radHeatFluxBf = - Qr.boundaryField(); + qr.boundaryField(); forAll(wallHeatFluxBf, patchi) { diff --git a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C index 6d6b1aaf18a16bf3e7b2b03e7e0ad770ecb6b2b1..81c22ddd5bfaba871737939cd8d34abb32c5d6e5 100644 --- a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C +++ b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C @@ -58,7 +58,7 @@ void reactingOneDim::readReactingOneDimControls() coeffs().lookup("minimumDelta") >> minimumDelta_; coeffs().lookup("gasHSource") >> gasHSource_; - coeffs().lookup("QrHSource") >> QrHSource_; + coeffs().lookup("qrHSource") >> qrHSource_; useChemistrySolvers_ = coeffs().lookupOrDefault<bool>("useChemistrySolvers", true); } @@ -92,41 +92,41 @@ bool reactingOneDim::read(const dictionary& dict) } -void reactingOneDim::updateQr() +void reactingOneDim::updateqr() { - // Update local Qr from coupled Qr field - Qr_ == dimensionedScalar("zero", Qr_.dimensions(), 0.0); + // Update local qr from coupled qr field + qr_ == dimensionedScalar("zero", qr_.dimensions(), 0.0); // Retrieve field from coupled region using mapped boundary conditions - Qr_.correctBoundaryConditions(); + qr_.correctBoundaryConditions(); - volScalarField::Boundary& QrBf = Qr_.boundaryFieldRef(); + volScalarField::Boundary& qrBf = qr_.boundaryFieldRef(); forAll(intCoupledPatchIDs_, i) { const label patchi = intCoupledPatchIDs_[i]; - // Qr is positive going in the solid + // qr is positive going in the solid // If the surface is emitting the radiative flux is set to zero - QrBf[patchi] = max(QrBf[patchi], scalar(0.0)); + qrBf[patchi] = max(qrBf[patchi], scalar(0.0)); } const vectorField& cellC = regionMesh().cellCentres(); tmp<volScalarField> kappa = kappaRad(); - // Propagate Qr through 1-D regions + // Propagate qr through 1-D regions label localPyrolysisFacei = 0; forAll(intCoupledPatchIDs_, i) { const label patchi = intCoupledPatchIDs_[i]; - const scalarField& Qrp = Qr_.boundaryField()[patchi]; + const scalarField& qrp = qr_.boundaryField()[patchi]; const vectorField& Cf = regionMesh().Cf().boundaryField()[patchi]; - forAll(Qrp, facei) + forAll(qrp, facei) { - const scalar Qr0 = Qrp[facei]; + const scalar qr0 = qrp[facei]; point Cf0 = Cf[facei]; const labelList& cells = boundaryFaceCells_[localPyrolysisFacei++]; scalar kappaInt = 0.0; @@ -136,7 +136,7 @@ void reactingOneDim::updateQr() const point& Cf1 = cellC[celli]; const scalar delta = mag(Cf1 - Cf0); kappaInt += kappa()[celli]*delta; - Qr_[celli] = Qr0*exp(-kappaInt); + qr_[celli] = qr0*exp(-kappaInt); Cf0 = Cf1; } } @@ -202,9 +202,9 @@ void reactingOneDim::updatePhiGas() void reactingOneDim::updateFields() { - if (QrHSource_) + if (qrHSource_) { - updateQr(); + updateqr(); } updatePhiGas(); @@ -332,10 +332,10 @@ void reactingOneDim::solveEnergy() hEqn += fvc::div(phiGas); } - if (QrHSource_) + if (qrHSource_) { - const surfaceScalarField phiQr(fvc::interpolate(Qr_)*nMagSf()); - hEqn += fvc::div(phiQr); + const surfaceScalarField phiqr(fvc::interpolate(qr_)*nMagSf()); + hEqn += fvc::div(phiqr); } if (regionMesh().moving()) @@ -447,11 +447,11 @@ reactingOneDim::reactingOneDim dimensionedScalar("zero", dimEnergy/dimTime/dimVolume, 0.0) ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", time().timeName(), regionMesh(), IOobject::MUST_READ, @@ -465,7 +465,7 @@ reactingOneDim::reactingOneDim totalGasMassFlux_(0.0), totalHeatRR_(dimensionedScalar("zero", dimEnergy/dimTime, 0.0)), gasHSource_(false), - QrHSource_(false), + qrHSource_(false), useChemistrySolvers_(true) { if (active_) @@ -547,11 +547,11 @@ reactingOneDim::reactingOneDim dimensionedScalar("zero", dimEnergy/dimTime/dimVolume, 0.0) ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", time().timeName(), regionMesh(), IOobject::MUST_READ, @@ -565,7 +565,7 @@ reactingOneDim::reactingOneDim totalGasMassFlux_(0.0), totalHeatRR_(dimensionedScalar("zero", dimEnergy/dimTime, 0.0)), gasHSource_(false), - QrHSource_(false), + qrHSource_(false), useChemistrySolvers_(true) { if (active_) diff --git a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H index a5b6ecfbce542c2eeecabaa209b0b80fd1a6af29..60083838a7e2074f38325ca036058a34de3eafdf 100644 --- a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H +++ b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -125,10 +125,10 @@ protected: //- Coupled region radiative heat flux [W/m2] // Requires user to input mapping info for coupled patches - //volScalarField QrCoupled_; + //volScalarField qrCoupled_; //- In depth radiative heat flux [W/m2] - volScalarField Qr_; + volScalarField qr_; // Checks @@ -152,7 +152,7 @@ protected: bool gasHSource_; //- Add in depth radiation source term - bool QrHSource_; + bool qrHSource_; //- Use chemistry solvers (ode or sequential) bool useChemistrySolvers_; @@ -173,7 +173,7 @@ protected: void updateMesh(const scalarField& mass0); //- Update radiative flux in pyrolysis region - void updateQr(); + void updateqr(); //- Update enthalpy flux for pyrolysis gases void updatePhiGas(); diff --git a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C index e5152f43c4dfeeadce6c01314bc54f94342d4980..dac63860b81a145b358556159c3197f0d0c28135 100644 --- a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C +++ b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -110,7 +110,7 @@ filmPyrolysisRadiativeCoupledMixedFvPatchScalarField filmRegionName_("surfaceFilmProperties"), pyrolysisRegionName_("pyrolysisProperties"), TnbrName_("undefined-Tnbr"), - QrName_("undefined-Qr"), + qrName_("undefined-qr"), convectiveScaling_(1.0), filmDeltaDry_(0.0), filmDeltaWet_(0.0) @@ -135,7 +135,7 @@ filmPyrolysisRadiativeCoupledMixedFvPatchScalarField filmRegionName_(psf.filmRegionName_), pyrolysisRegionName_(psf.pyrolysisRegionName_), TnbrName_(psf.TnbrName_), - QrName_(psf.QrName_), + qrName_(psf.qrName_), convectiveScaling_(psf.convectiveScaling_), filmDeltaDry_(psf.filmDeltaDry_), filmDeltaWet_(psf.filmDeltaWet_) @@ -161,7 +161,7 @@ filmPyrolysisRadiativeCoupledMixedFvPatchScalarField dict.lookupOrDefault<word>("pyrolysisRegion", "pyrolysisProperties") ), TnbrName_(dict.lookup("Tnbr")), - QrName_(dict.lookup("Qr")), + qrName_(dict.lookup("qr")), convectiveScaling_(dict.lookupOrDefault<scalar>("convectiveScaling", 1.0)), filmDeltaDry_(readScalar(dict.lookup("filmDeltaDry"))), filmDeltaWet_(readScalar(dict.lookup("filmDeltaWet"))) @@ -207,7 +207,7 @@ filmPyrolysisRadiativeCoupledMixedFvPatchScalarField filmRegionName_(psf.filmRegionName_), pyrolysisRegionName_(psf.pyrolysisRegionName_), TnbrName_(psf.TnbrName_), - QrName_(psf.QrName_), + qrName_(psf.qrName_), convectiveScaling_(psf.convectiveScaling_), filmDeltaDry_(psf.filmDeltaDry_), filmDeltaWet_(psf.filmDeltaWet_) @@ -268,25 +268,25 @@ void filmPyrolysisRadiativeCoupledMixedFvPatchScalarField::updateCoeffs() const pyrolysisModelType& pyrolysis = pyrModel(); const filmModelType& film = filmModel(); - // Obtain Rad heat (Qr) - scalarField Qr(patch().size(), 0.0); + // Obtain Rad heat (qr) + scalarField qr(patch().size(), 0.0); label coupledPatchi = -1; if (pyrolysisRegionName_ == mesh.name()) { coupledPatchi = patchi; - if (QrName_ != "none") + if (qrName_ != "none") { - Qr = nbrPatch.lookupPatchField<volScalarField, scalar>(QrName_); - mpp.distribute(Qr); + qr = nbrPatch.lookupPatchField<volScalarField, scalar>(qrName_); + mpp.distribute(qr); } } else if (pyrolysis.primaryMesh().name() == mesh.name()) { coupledPatchi = nbrPatch.index(); - if (QrName_ != "none") + if (qrName_ != "none") { - Qr = patch().lookupPatchField<volScalarField, scalar>(QrName_); + qr = patch().lookupPatchField<volScalarField, scalar>(qrName_); } } else @@ -344,7 +344,7 @@ void filmPyrolysisRadiativeCoupledMixedFvPatchScalarField::updateCoeffs() scalarField qConv(ratio*htcwfilm*(Tfilm - Tp)*convectiveScaling_); - scalarField qRad((1.0 - ratio)*Qr); + scalarField qRad((1.0 - ratio)*qr); scalarField alpha(KDeltaNbr - (qRad + qConv)/Tp); @@ -357,7 +357,7 @@ void filmPyrolysisRadiativeCoupledMixedFvPatchScalarField::updateCoeffs() if (debug) { scalar Qc = gSum(qConv*patch().magSf()); - scalar Qr = gSum(qRad*patch().magSf()); + scalar qr = gSum(qRad*patch().magSf()); scalar Qt = gSum((qConv + qRad)*patch().magSf()); Info<< mesh.name() << ':' @@ -367,7 +367,7 @@ void filmPyrolysisRadiativeCoupledMixedFvPatchScalarField::updateCoeffs() << nbrPatch.name() << ':' << this->internalField().name() << " :" << nl << " convective heat[W] : " << Qc << nl - << " radiative heat [W] : " << Qr << nl + << " radiative heat [W] : " << qr << nl << " total heat [W] : " << Qt << nl << " wall temperature " << " min:" << gMin(*this) @@ -399,7 +399,7 @@ void filmPyrolysisRadiativeCoupledMixedFvPatchScalarField::write pyrolysisRegionName_ ); os.writeKeyword("Tnbr")<< TnbrName_ << token::END_STATEMENT << nl; - os.writeKeyword("Qr")<< QrName_ << token::END_STATEMENT << nl; + os.writeKeyword("qr")<< qrName_ << token::END_STATEMENT << nl; os.writeKeyword("convectiveScaling") << convectiveScaling_ << token::END_STATEMENT << nl; os.writeKeyword("filmDeltaDry") << filmDeltaDry_ diff --git a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H index 6375c32c863a83208e1d890b0800d549f6a6ad76..8f04799d59f9a9ee05f5806da9af71931a68eba0 100644 --- a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H +++ b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -35,7 +35,7 @@ Description type filmPyrolysisRadiativeCoupledMixed; Tnbr T; kappa fluidThermo; - Qr Qr; + qr qr; kappaName none; filmDeltaDry 0.0; filmDeltaWet 3e-4; @@ -58,7 +58,7 @@ Description \verbatim qConv = ratio*htcwfilm*(Tfilm - *this); - qRad = (1.0 - ratio)*Qr; + qRad = (1.0 - ratio)*qr; \endverbatim Then the solid can gain or loose energy through radiation or conduction @@ -67,7 +67,7 @@ Description Notes: - kappa and \c kappaName are inherited from temperatureCoupledBase. - - Qr is the radiative flux defined in the radiation model. + - qr is the radiative flux defined in the radiation model. See also @@ -124,7 +124,7 @@ private: const word TnbrName_; //- Name of the radiative heat flux - const word QrName_; + const word qrName_; //- Convective Scaling Factor (as determined by Prateep's tests) const scalar convectiveScaling_; diff --git a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.C b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.C index 0dcb6ebe9ca180eda97cb00c6a046289b6764136..64c6be61185044466ef2786766c6e25feb34839d 100644 --- a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.C +++ b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.C @@ -56,11 +56,11 @@ constantRadiation::constantRadiation ) : filmRadiationModel(typeName, film, dict), - QrConst_ + qrConst_ ( IOobject ( - typeName + ":QrConst", + typeName + ":qrConst", film.time().timeName(), film.regionMesh(), IOobject::MUST_READ, @@ -125,10 +125,10 @@ tmp<volScalarField> constantRadiation::Shs() if ((time >= timeStart_) && (time <= timeStart_ + duration_)) { scalarField& Shs = tShs.ref(); - const scalarField& Qr = QrConst_; + const scalarField& qr = qrConst_; const scalarField& alpha = filmModel_.alpha(); - Shs = mask_*Qr*alpha*absorptivity_; + Shs = mask_*qr*alpha*absorptivity_; } return tShs; diff --git a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.H b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.H index 76a2d9a7719e5397588653fef7a41bae0211668e..f33dc1dbe8ff9ea81e4bf6ecb0d5387485c116bc 100644 --- a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.H +++ b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/constantRadiation/constantRadiation.H @@ -63,7 +63,7 @@ private: // Private data //- Constant radiative flux [kg/s3] - volScalarField QrConst_; + volScalarField qrConst_; //- Radiation mask volScalarField mask_; @@ -115,7 +115,7 @@ public: virtual void correct(); //- Return the radiation sensible enthalpy source - // Also updates QrNet + // Also updates qrNet virtual tmp<volScalarField> Shs(); }; diff --git a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/primaryRadiation/primaryRadiation.H b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/primaryRadiation/primaryRadiation.H index 55f9d1a828787bd1082e95c61b8019dc7a01c388..d2b9da585cf3c8decdb8b63f7bc28eec76164aab 100644 --- a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/primaryRadiation/primaryRadiation.H +++ b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/primaryRadiation/primaryRadiation.H @@ -101,7 +101,7 @@ public: virtual void correct(); //- Return the radiation sensible enthalpy source - // Also updates QrNet + // Also updates qrNet virtual tmp<volScalarField> Shs(); }; diff --git a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.C b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.C index 0c82cf5e33bed7c00f6214818cdec60609d09f4e..f333752847f435abf238e5af01eea0e2c0c97156 100644 --- a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.C +++ b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.C @@ -71,11 +71,11 @@ standardRadiation::standardRadiation dimensionedScalar("zero", dimMass/pow3(dimTime), 0.0), film.mappedPushedFieldPatchTypes<scalar>() ), - QrNet_ + qrNet_ ( IOobject ( - "QrNet", + "qrNet", film.time().timeName(), film.regionMesh(), IOobject::NO_READ, @@ -100,7 +100,7 @@ standardRadiation::~standardRadiation() void standardRadiation::correct() { - // Transfer Qr from primary region + // Transfer qr from primary region QinPrimary_.correctBoundaryConditions(); } @@ -131,9 +131,9 @@ tmp<volScalarField> standardRadiation::Shs() Shs = beta_*QinP*alpha*(1.0 - exp(-kappaBar_*delta)); - // Update net Qr on local region - QrNet_.primitiveFieldRef() = QinP - Shs; - QrNet_.correctBoundaryConditions(); + // Update net qr on local region + qrNet_.primitiveFieldRef() = QinP - Shs; + qrNet_.correctBoundaryConditions(); return tShs; } diff --git a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.H b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.H index 8a4912bd523389d40765d2bc1ef60635434115d4..191f1dab9d8aefb9a44e4eca2b40fd7e1c8a0fce 100644 --- a/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.H +++ b/src/regionModels/surfaceFilmModels/submodels/thermo/filmRadiationModel/standardRadiation/standardRadiation.H @@ -63,7 +63,7 @@ private: volScalarField QinPrimary_; //- Remaining radiative flux after removing local contribution - volScalarField QrNet_; + volScalarField qrNet_; // Model coefficients @@ -112,7 +112,7 @@ public: virtual void correct(); //- Return the radiation sensible enthalpy source - // Also updates QrNet + // Also updates qrNet virtual tmp<volScalarField> Shs(); }; diff --git a/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H b/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H index b29bab13a4eb923d629762ec6677512ea99eae5a..bc8bcf848de5e81fe9bc45eaffe4942e37048f23 100644 --- a/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H +++ b/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H @@ -54,8 +54,8 @@ Usage Tnbr T; kappa fluidThermo; // or solidThermo KappaName none; - QrNbr Qr;//or none.Name of Qr field on neighbourregion - Qr none;// or none.Name of Qr field on localregion + qrNbr qr;//or none.Name of qr field on neighbourregion + qr none;// or none.Name of qr field on localregion value uniform 300; // Baffle region name diff --git a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C index cd4d4827d2fe7ad53b109f8c83567def7176fe6f..f5723b6e29e285f4c3415da2adae1a68e8ea0026 100644 --- a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C +++ b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -185,7 +185,7 @@ updateCoeffs() const scalarField nAve(n & ray.dAve()); - ray.Qr().boundaryFieldRef()[patchi] += Iw*nAve; + ray.qr().boundaryFieldRef()[patchi] += Iw*nAve; const scalarField temissivity = emissivity(); diff --git a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.C b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.C index 591d6d1964c173ea67b20f7c3c54c7c88ec4f6a4..70110f20e32f0ed6c318a8632c80f11d00ede48d 100644 --- a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.C +++ b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -40,7 +40,7 @@ greyDiffusiveViewFactorFixedValueFvPatchScalarField : fixedValueFvPatchScalarField(p, iF), radiationCoupledBase(patch(), "undefined", scalarField::null()), - Qro_(p.size(), 0.0) + qro_(p.size(), 0.0) {} @@ -60,7 +60,7 @@ greyDiffusiveViewFactorFixedValueFvPatchScalarField ptf.emissivityMethod(), ptf.emissivity_ ), - Qro_(ptf.Qro_) + qro_(ptf.qro_) {} @@ -74,7 +74,7 @@ greyDiffusiveViewFactorFixedValueFvPatchScalarField : fixedValueFvPatchScalarField(p, iF, dict, false), radiationCoupledBase(p, dict), - Qro_("Qro", dict, p.size()) + qro_("qro", dict, p.size()) { if (dict.found("value")) { @@ -104,7 +104,7 @@ greyDiffusiveViewFactorFixedValueFvPatchScalarField ptf.emissivityMethod(), ptf.emissivity_ ), - Qro_(ptf.Qro_) + qro_(ptf.qro_) {} @@ -122,7 +122,7 @@ greyDiffusiveViewFactorFixedValueFvPatchScalarField ptf.emissivityMethod(), ptf.emissivity_ ), - Qro_(ptf.Qro_) + qro_(ptf.qro_) {} @@ -163,7 +163,7 @@ write { fixedValueFvPatchScalarField::write(os); radiationCoupledBase::write(os); - Qro_.writeEntry("Qro", os); + qro_.writeEntry("qro", os); } diff --git a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.H b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.H index 7a5085c95180a54df392d7b861c4c14b996abd97..ea5cbac622563a148c94364c66e6b0cf51b1fea9 100644 --- a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.H +++ b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveViewFactor/greyDiffusiveViewFactorFixedValueFvPatchScalarField.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,12 +29,12 @@ Group Description This boundary condition provides a grey-diffuse condition for radiative - heat flux, \c Qr, for use with the view factor model + heat flux, \c qr, for use with the view factor model Usage \table Property | Description | Required | Default value - Qro | external radiative heat flux | yes | + qro | external radiative heat flux | yes | emissivityMode | emissivity mode: solidRadiation or lookup | yes | \endtable @@ -43,7 +43,7 @@ Usage <patchName> { type greyDiffusiveRadiationViewFactor; - Qro uniform 0; + qro uniform 0; emissivityMode solidRadiation; value uniform 0; } @@ -85,7 +85,7 @@ class greyDiffusiveViewFactorFixedValueFvPatchScalarField // Private data //- External radiative heat flux - scalarField Qro_; + scalarField qro_; public: @@ -165,9 +165,9 @@ public: // Access //- Return external radiative heat flux - const scalarList& Qro() + const scalarList& qro() { - return Qro_; + return qro_; } diff --git a/src/thermophysicalModels/radiation/derivedFvPatchFields/wideBandDiffusiveRadiation/wideBandDiffusiveRadiationMixedFvPatchScalarField.C b/src/thermophysicalModels/radiation/derivedFvPatchFields/wideBandDiffusiveRadiation/wideBandDiffusiveRadiationMixedFvPatchScalarField.C index d77a56a845cf3688ddeb79a3c33181036981456a..21654e1542996f9c1fb1adf473753f71d011bca4 100644 --- a/src/thermophysicalModels/radiation/derivedFvPatchFields/wideBandDiffusiveRadiation/wideBandDiffusiveRadiationMixedFvPatchScalarField.C +++ b/src/thermophysicalModels/radiation/derivedFvPatchFields/wideBandDiffusiveRadiation/wideBandDiffusiveRadiationMixedFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -186,7 +186,7 @@ updateCoeffs() const scalarField nAve(n & ray.dAve()); - ray.Qr().boundaryFieldRef()[patchi] += Iw*nAve; + ray.qr().boundaryFieldRef()[patchi] += Iw*nAve; const scalarField Eb ( diff --git a/src/thermophysicalModels/radiation/radiationModels/P1/P1.C b/src/thermophysicalModels/radiation/radiationModels/P1/P1.C index 3032cca499e240a51f7783fea1c197a082eb5d8e..edb306e321ac509cb2bf372f4efd6454b8e9086d 100644 --- a/src/thermophysicalModels/radiation/radiationModels/P1/P1.C +++ b/src/thermophysicalModels/radiation/radiationModels/P1/P1.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -62,18 +62,18 @@ Foam::radiation::P1::P1(const volScalarField& T) ), mesh_ ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", mesh_.time().timeName(), mesh_, IOobject::NO_READ, IOobject::AUTO_WRITE ), mesh_, - dimensionedScalar("Qr", dimMass/pow3(dimTime), 0.0) + dimensionedScalar("qr", dimMass/pow3(dimTime), 0.0) ), a_ ( @@ -132,18 +132,18 @@ Foam::radiation::P1::P1(const dictionary& dict, const volScalarField& T) ), mesh_ ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", mesh_.time().timeName(), mesh_, IOobject::NO_READ, IOobject::AUTO_WRITE ), mesh_, - dimensionedScalar("Qr", dimMass/pow3(dimTime), 0.0) + dimensionedScalar("qr", dimMass/pow3(dimTime), 0.0) ), a_ ( @@ -242,14 +242,14 @@ void Foam::radiation::P1::calculate() - 4.0*(e_*physicoChemical::sigma*pow4(T_) ) - E_ ); - volScalarField::Boundary& QrBf = Qr_.boundaryFieldRef(); + volScalarField::Boundary& qrBf = qr_.boundaryFieldRef(); // Calculate radiative heat flux on boundaries. forAll(mesh_.boundaryMesh(), patchi) { if (!G_.boundaryField()[patchi].coupled()) { - QrBf[patchi] = + qrBf[patchi] = -gamma.boundaryField()[patchi] *G_.boundaryField()[patchi].snGrad(); } diff --git a/src/thermophysicalModels/radiation/radiationModels/P1/P1.H b/src/thermophysicalModels/radiation/radiationModels/P1/P1.H index 38cdd4fcfa5f335f583a21fbe85161e0ba16963c..b4a5044a1155593198d8c8e6a9b3d9d579105a0d 100644 --- a/src/thermophysicalModels/radiation/radiationModels/P1/P1.H +++ b/src/thermophysicalModels/radiation/radiationModels/P1/P1.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -65,7 +65,7 @@ class P1 volScalarField G_; //- Total radiative heat flux [W/m2] - volScalarField Qr_; + volScalarField qr_; //- Absorption coefficient volScalarField a_; diff --git a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C index 164534ff5755857b46a5c88de09c8e2260d1e35c..01db9565a36411dff5f81084689c6d13173bc308 100644 --- a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C +++ b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -222,18 +222,18 @@ Foam::radiation::fvDOM::fvDOM(const volScalarField& T) mesh_, dimensionedScalar("G", dimMass/pow3(dimTime), 0.0) ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", mesh_.time().timeName(), mesh_, IOobject::READ_IF_PRESENT, IOobject::AUTO_WRITE ), mesh_, - dimensionedScalar("Qr", dimMass/pow3(dimTime), 0.0) + dimensionedScalar("qr", dimMass/pow3(dimTime), 0.0) ), Qem_ ( @@ -309,18 +309,18 @@ Foam::radiation::fvDOM::fvDOM mesh_, dimensionedScalar("G", dimMass/pow3(dimTime), 0.0) ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", mesh_.time().timeName(), mesh_, IOobject::READ_IF_PRESENT, IOobject::AUTO_WRITE ), mesh_, - dimensionedScalar("Qr", dimMass/pow3(dimTime), 0.0) + dimensionedScalar("qr", dimMass/pow3(dimTime), 0.0) ), Qem_ ( @@ -490,7 +490,7 @@ void Foam::radiation::fvDOM::updateBlackBodyEmission() void Foam::radiation::fvDOM::updateG() { G_ = dimensionedScalar("zero",dimMass/pow3(dimTime), 0.0); - Qr_ = dimensionedScalar("zero",dimMass/pow3(dimTime), 0.0); + qr_ = dimensionedScalar("zero",dimMass/pow3(dimTime), 0.0); Qem_ = dimensionedScalar("zero", dimMass/pow3(dimTime), 0.0); Qin_ = dimensionedScalar("zero", dimMass/pow3(dimTime), 0.0); @@ -498,7 +498,7 @@ void Foam::radiation::fvDOM::updateG() { IRay_[rayI].addIntensity(); G_ += IRay_[rayI].I()*IRay_[rayI].omega(); - Qr_.boundaryFieldRef() += IRay_[rayI].Qr().boundaryField(); + qr_.boundaryFieldRef() += IRay_[rayI].qr().boundaryField(); Qem_.boundaryFieldRef() += IRay_[rayI].Qem().boundaryField(); Qin_.boundaryFieldRef() += IRay_[rayI].Qin().boundaryField(); } diff --git a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.H b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.H index 1154b6cafcbfbd68607fb6d5eafd0695b149bc43..ed853850e760c38ce179232694db4739b91bb5fd 100644 --- a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.H +++ b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -89,7 +89,7 @@ class fvDOM volScalarField G_; //- Total radiative heat flux [W/m2] - volScalarField Qr_; + volScalarField qr_; //- Emmited radiative heat flux [W/m2] volScalarField Qem_; @@ -228,7 +228,7 @@ public: inline const volScalarField& G() const; //- Const access to total radiative heat flux field - inline const volScalarField& Qr() const; + inline const volScalarField& qr() const; //- Const access to incident radiative heat flux field inline const volScalarField& Qin() const; diff --git a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOMI.H b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOMI.H index d2255b2de088f5461b048a35de9463d605010a3e..6197b88e135214aa79217d4feaaef636baa22951 100644 --- a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOMI.H +++ b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOMI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -86,9 +86,9 @@ inline const Foam::volScalarField& Foam::radiation::fvDOM::G() const } -inline const Foam::volScalarField& Foam::radiation::fvDOM::Qr() const +inline const Foam::volScalarField& Foam::radiation::fvDOM::qr() const { - return Qr_; + return qr_; } inline const Foam::volScalarField& Foam::radiation::fvDOM::Qin() const diff --git a/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.C b/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.C index d77654138409b9902310a9612e887f4c992994e5..2efa48026d8f6b64abc89fa2e923a5d5c18b0467 100644 --- a/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.C +++ b/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -69,18 +69,18 @@ Foam::radiation::radiativeIntensityRay::radiativeIntensityRay mesh_, dimensionedScalar("I", dimMass/pow3(dimTime), 0.0) ), - Qr_ + qr_ ( IOobject ( - "Qr" + name(rayId), + "qr" + name(rayId), mesh_.time().timeName(), mesh_, IOobject::NO_READ, IOobject::NO_WRITE ), mesh_, - dimensionedScalar("Qr", dimMass/pow3(dimTime), 0.0) + dimensionedScalar("qr", dimMass/pow3(dimTime), 0.0) ), Qin_ ( @@ -206,7 +206,7 @@ Foam::radiation::radiativeIntensityRay::~radiativeIntensityRay() Foam::scalar Foam::radiation::radiativeIntensityRay::correct() { // Reset boundary heat flux to zero - Qr_.boundaryFieldRef() = 0.0; + qr_.boundaryFieldRef() = 0.0; scalar maxResidual = -GREAT; diff --git a/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.H b/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.H index e98081378e6bcbad5795e04c8cd0063d47f89562..2dc4eb411346fb521432c4941994f196f2cffa9f 100644 --- a/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.H +++ b/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRay.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -80,7 +80,7 @@ private: volScalarField I_; //- Total radiative heat flux on boundary - volScalarField Qr_; + volScalarField qr_; //- Incident radiative heat flux on boundary volScalarField Qin_; @@ -176,10 +176,10 @@ public: inline const volScalarField& I() const; //- Return const access to the boundary heat flux - inline const volScalarField& Qr() const; + inline const volScalarField& qr() const; //- Return non-const access to the boundary heat flux - inline volScalarField& Qr(); + inline volScalarField& qr(); //- Return non-const access to the boundary incident heat flux inline volScalarField& Qin(); diff --git a/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRayI.H b/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRayI.H index 8761f900b4fc57055cdf31b6615d329a6e624caf..d307d890bc0233154148a7c670fc60a4921dffc9 100644 --- a/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRayI.H +++ b/src/thermophysicalModels/radiation/radiationModels/fvDOM/radiativeIntensityRay/radiativeIntensityRayI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -31,15 +31,15 @@ Foam::radiation::radiativeIntensityRay::I() const inline const Foam::volScalarField& -Foam::radiation::radiativeIntensityRay::Qr() const +Foam::radiation::radiativeIntensityRay::qr() const { - return Qr_; + return qr_; } -inline Foam::volScalarField& Foam::radiation::radiativeIntensityRay::Qr() +inline Foam::volScalarField& Foam::radiation::radiativeIntensityRay::qr() { - return Qr_; + return qr_; } inline const Foam::volScalarField& Foam::radiation:: diff --git a/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.C b/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.C index d768cd394268f73f8b0705205b433ad11c7a0d6e..47e7e2fadf55499a2dbe064970dcf6236348ea1c 100644 --- a/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.C +++ b/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -49,17 +49,17 @@ namespace Foam void Foam::radiation::viewFactor::initialise() { const polyBoundaryMesh& coarsePatches = coarseMesh_.boundaryMesh(); - const volScalarField::Boundary& Qrp = Qr_.boundaryField(); + const volScalarField::Boundary& qrp = qr_.boundaryField(); label count = 0; - forAll(Qrp, patchi) + forAll(qrp, patchi) { //const polyPatch& pp = mesh_.boundaryMesh()[patchi]; - const fvPatchScalarField& QrPatchi = Qrp[patchi]; + const fvPatchScalarField& qrPatchi = qrp[patchi]; - if ((isA<fixedValueFvPatchScalarField>(QrPatchi))) + if ((isA<fixedValueFvPatchScalarField>(qrPatchi))) { - selectedPatches_[count] = QrPatchi.patch().index(); + selectedPatches_[count] = qrPatchi.patch().index(); nLocalCoarseFaces_ += coarsePatches[patchi].size(); count++; } @@ -264,11 +264,11 @@ Foam::radiation::viewFactor::viewFactor(const volScalarField& T) mesh_, finalAgglom_ ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", mesh_.time().timeName(), mesh_, IOobject::MUST_READ, @@ -322,11 +322,11 @@ Foam::radiation::viewFactor::viewFactor mesh_, finalAgglom_ ), - Qr_ + qr_ ( IOobject ( - "Qr", + "qr", mesh_.time().timeName(), mesh_, IOobject::MUST_READ, @@ -394,7 +394,7 @@ void Foam::radiation::viewFactor::insertMatrixElements void Foam::radiation::viewFactor::calculate() { // Store previous iteration - Qr_.storePrevIter(); + qr_.storePrevIter(); scalarField compactCoarseT(map_->constructSize(), 0.0); scalarField compactCoarseE(map_->constructSize(), 0.0); @@ -407,7 +407,7 @@ void Foam::radiation::viewFactor::calculate() DynamicList<scalar> localCoarseEave(nLocalCoarseFaces_); DynamicList<scalar> localCoarseHoave(nLocalCoarseFaces_); - volScalarField::Boundary& QrBf = Qr_.boundaryFieldRef(); + volScalarField::Boundary& qrBf = qr_.boundaryFieldRef(); forAll(selectedPatches_, i) { @@ -416,17 +416,17 @@ void Foam::radiation::viewFactor::calculate() const scalarField& Tp = T_.boundaryField()[patchID]; const scalarField& sf = mesh_.magSf().boundaryField()[patchID]; - fvPatchScalarField& QrPatch = QrBf[patchID]; + fvPatchScalarField& qrPatch = qrBf[patchID]; - greyDiffusiveViewFactorFixedValueFvPatchScalarField& Qrp = + greyDiffusiveViewFactorFixedValueFvPatchScalarField& qrp = refCast < greyDiffusiveViewFactorFixedValueFvPatchScalarField - >(QrPatch); + >(qrPatch); - const scalarList eb = Qrp.emissivity(); + const scalarList eb = qrp.emissivity(); - const scalarList& Hoi = Qrp.Qro(); + const scalarList& Hoi = qrp.qro(); const polyPatch& pp = coarseMesh_.boundaryMesh()[patchID]; const labelList& coarsePatchFace = coarseMesh_.patchFaceMap()[patchID]; @@ -499,23 +499,23 @@ void Foam::radiation::viewFactor::calculate() // Create global size vectors scalarField T(totalNCoarseFaces_, 0.0); scalarField E(totalNCoarseFaces_, 0.0); - scalarField QrExt(totalNCoarseFaces_, 0.0); + scalarField qrExt(totalNCoarseFaces_, 0.0); // Fill lists from compact to global indexes. forAll(compactCoarseT, i) { T[compactGlobalIds[i]] = compactCoarseT[i]; E[compactGlobalIds[i]] = compactCoarseE[i]; - QrExt[compactGlobalIds[i]] = compactCoarseHo[i]; + qrExt[compactGlobalIds[i]] = compactCoarseHo[i]; } Pstream::listCombineGather(T, maxEqOp<scalar>()); Pstream::listCombineGather(E, maxEqOp<scalar>()); - Pstream::listCombineGather(QrExt, maxEqOp<scalar>()); + Pstream::listCombineGather(qrExt, maxEqOp<scalar>()); Pstream::listCombineScatter(T); Pstream::listCombineScatter(E); - Pstream::listCombineScatter(QrExt); + Pstream::listCombineScatter(qrExt); // Net radiation scalarField q(totalNCoarseFaces_, 0.0); @@ -538,7 +538,7 @@ void Foam::radiation::viewFactor::calculate() if (i==j) { C(i, j) = invEj - (invEj - 1.0)*Fmatrix_()(i, j); - q[i] += (Fmatrix_()(i, j) - 1.0)*sigmaT4 - QrExt[j]; + q[i] += (Fmatrix_()(i, j) - 1.0)*sigmaT4 - qrExt[j]; } else { @@ -594,7 +594,7 @@ void Foam::radiation::viewFactor::calculate() if (i==j) { - q[i] += (Fmatrix_()(i, j) - 1.0)*sigmaT4 - QrExt[j]; + q[i] += (Fmatrix_()(i, j) - 1.0)*sigmaT4 - qrExt[j]; } else { @@ -614,7 +614,7 @@ void Foam::radiation::viewFactor::calculate() } } - // Scatter q and fill Qr + // Scatter q and fill qr Pstream::listCombineScatter(q); Pstream::listCombineGather(q, maxEqOp<scalar>()); @@ -625,7 +625,7 @@ void Foam::radiation::viewFactor::calculate() const polyPatch& pp = mesh_.boundaryMesh()[patchID]; if (pp.size() > 0) { - scalarField& Qrp = QrBf[patchID]; + scalarField& qrp = qrBf[patchID]; const scalarField& sf = mesh_.magSf().boundaryField()[patchID]; const labelList& agglom = finalAgglom_[patchID]; label nAgglom = max(agglom)+1; @@ -646,8 +646,8 @@ void Foam::radiation::viewFactor::calculate() { label facei = fineFaces[k]; - Qrp[facei] = q[globalCoarse]; - heatFlux += Qrp[facei]*sf[facei]; + qrp[facei] = q[globalCoarse]; + heatFlux += qrp[facei]*sf[facei]; } globCoarseId ++; } @@ -656,11 +656,11 @@ void Foam::radiation::viewFactor::calculate() if (debug) { - forAll(QrBf, patchID) + forAll(qrBf, patchID) { - const scalarField& Qrp = QrBf[patchID]; + const scalarField& qrp = qrBf[patchID]; const scalarField& magSf = mesh_.magSf().boundaryField()[patchID]; - scalar heatFlux = gSum(Qrp*magSf); + scalar heatFlux = gSum(qrp*magSf); InfoInFunction << "Total heat transfer rate at patch: " @@ -669,8 +669,8 @@ void Foam::radiation::viewFactor::calculate() } } - // Relax Qr if necessary - Qr_.relax(); + // Relax qr if necessary + qr_.relax(); } diff --git a/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.H b/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.H index 86d244339cdacf06bf3013b9d94ac16647b5c418..1b3c56e0abf6fa472e4acad0b5ff29a11b7c933c 100644 --- a/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.H +++ b/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactor.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -80,7 +80,7 @@ class viewFactor singleCellFvMesh coarseMesh_; //- Net radiative heat flux [W/m2] - volScalarField Qr_; + volScalarField qr_; //- View factor matrix autoPtr<scalarSquareMatrix> Fmatrix_; @@ -168,7 +168,7 @@ public: // Access //- Const access to total radiative heat flux field - inline const volScalarField& Qr() const; + inline const volScalarField& qr() const; }; diff --git a/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactorI.H b/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactorI.H index e45f9a8ba0b42211903ded1f4f33425b2e2f81e4..b03f886ab21c6028b991e7fb5b793c9f80ecdab7 100644 --- a/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactorI.H +++ b/src/thermophysicalModels/radiation/radiationModels/viewFactor/viewFactorI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -23,11 +23,10 @@ License \*---------------------------------------------------------------------------*/ -inline const Foam::volScalarField& Foam::radiation::viewFactor::Qr() const +inline const Foam::volScalarField& Foam::radiation::viewFactor::qr() const { - return Qr_; + return qr_; } - // ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/T b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/T index 6e4926f22c5bde5aadf22e23ec7be6a8d4424a2b..bce2317b717b4061bd5f053138487a39800e8b69 100644 --- a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/T +++ b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/T @@ -53,8 +53,8 @@ boundaryField filmRegion filmRegion; Tnbr T; kappaMethod fluidThermo; - QrNbr none; - Qr Qr; + qrNbr none; + qr qr; filmDeltaDry 0.0; filmDeltaWet 2e-4; value $internalField; diff --git a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/T b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/T index 6a25deb6ac8141e55dd45445860bce13464fdb3b..e7825bfa0529cdc01fb7411eb90f76610ca356bb 100644 --- a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/T +++ b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/T @@ -38,8 +38,8 @@ boundaryField filmRegion filmRegion; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; filmDeltaDry 0.0; filmDeltaWet 2e-4; value uniform 298; diff --git a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Qr b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/qr similarity index 94% rename from tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Qr rename to tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/qr index 688990cd4804e8768ab47747c0b639f64cc1e80a..b5677efa7156907c3286ef555ff0854a16be95f1 100644 --- a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Qr +++ b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/qr @@ -11,7 +11,7 @@ FoamFile format ascii; class volScalarField; location "0"; - object Qr; + object qr; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -38,7 +38,7 @@ boundaryField sampleMode nearestPatchFace; samplePatch region0_to_pyrolysisRegion_coupledWall; offset (0 0 0); - field Qr; // this is the name of Qr field in region0 + field qr; // this is the name of qr field in region0 setAverage no; average 0; value uniform 0; diff --git a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/constant/pyrolysisZones b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/constant/pyrolysisZones index d988145a1ce725c1d45b5d1d6da497711fe07fad..b240d80b883db803c194c470d6c614c21a92afa0 100644 --- a/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/constant/pyrolysisZones +++ b/tutorials/combustion/fireFoam/LES/flameSpreadWaterSuppressionPanel/constant/pyrolysisZones @@ -28,9 +28,9 @@ pyrolysis filmCoupled true; gasHSource true; - QrHSource false; + qrHSource false; - radFluxName Qr; + radFluxName qr; moveMesh false; // true; minimumDelta 1e-6; diff --git a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/T b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/T index da6eb73e6eb0414ff6fda3a4d49d19f3f45c0cb3..8a8763bd3599980d207416913c44f620cb13680e 100644 --- a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/T +++ b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/T @@ -51,8 +51,8 @@ boundaryField type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod fluidThermo; - QrNbr none; - Qr Qr; + qrNbr none; + qr qr; value $internalField; } } diff --git a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/T b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/T index 386d3ff0bdf0fc943921f617ab99a5beeac185b2..2d309bd1aab3289ec464ec091bb2e3ba3468007d 100644 --- a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/T +++ b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/T @@ -42,8 +42,8 @@ boundaryField type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; value uniform 298.15; } diff --git a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/Qr b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/qr similarity index 96% rename from tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/Qr rename to tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/qr index ad9baa15862e3a18b95aa6bdebb80232365f3095..c1ca71db756647298f6219ac6382c276b3bd3b8f 100644 --- a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/Qr +++ b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/0/panelRegion/qr @@ -11,7 +11,7 @@ FoamFile format ascii; class volScalarField; location "0"; - object Qr; + object qr; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -43,7 +43,7 @@ boundaryField sampleMode nearestPatchFace; samplePatch region0_to_panelRegion_fLeft_zone; offset (0 0 0); - field Qr; + field qr; setAverage no; average 0; value uniform 0; @@ -56,7 +56,7 @@ boundaryField sampleMode nearestPatchFace; samplePatch region0_to_panelRegion_fRight_zone; offset (0 0 0); - field Qr; + field qr; setAverage no; average 0; value uniform 0; diff --git a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/constant/pyrolysisZones b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/constant/pyrolysisZones index 2c505a9ecb2d9b0612a1ddb4ded964e257e2fdc7..8ab8cca2907f7bf9077b88e1f8fb1914000a6f67 100644 --- a/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/constant/pyrolysisZones +++ b/tutorials/combustion/fireFoam/LES/oppositeBurningPanels/constant/pyrolysisZones @@ -26,7 +26,7 @@ pyrolysis reactingOneDimCoeffs { gasHSource false; //Energy source term due to pyrolysis gas - QrHSource false; //Energy source term due in depht radiation + qrHSource false; //Energy source term due in depht radiation minimumDelta 1e-12; reactionDeltaMin 1e-12; diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/pyrolysisZones b/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/pyrolysisZones index d556e449ab389e1aff3e00806af4db73ca2bcec4..4cc5fcb097bbc9d8ae75239fa5010ad8d24cdd3e 100644 --- a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/pyrolysisZones +++ b/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/pyrolysisZones @@ -25,7 +25,7 @@ pyrolysis reactingOneDimCoeffs { - radFluxName Qr; + radFluxName qr; minimumDelta 1e-8; diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/pyrolysisZones b/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/pyrolysisZones index d556e449ab389e1aff3e00806af4db73ca2bcec4..4cc5fcb097bbc9d8ae75239fa5010ad8d24cdd3e 100644 --- a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/pyrolysisZones +++ b/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/pyrolysisZones @@ -25,7 +25,7 @@ pyrolysis reactingOneDimCoeffs { - radFluxName Qr; + radFluxName qr; minimumDelta 1e-8; diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/0/Qr b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/0/qr similarity index 98% rename from tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/0/Qr rename to tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/0/qr index 12ee0f2fe9b0560a92651891fdad83ff37e7425c..b7ec516043715884dcc9ef201f64a897ee2a4177 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/0/Qr +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/0/qr @@ -10,7 +10,7 @@ FoamFile version 2.0; format ascii; class volScalarField; - object Qr; + object qr; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun.pre b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun.pre index 22b2e59f126117fc69efe40e2c3c9d2709fe41eb..e2f33a7785dbcc032438b33a5202ffa1c4cb0a4f 100755 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun.pre +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun.pre @@ -12,7 +12,7 @@ runApplication splitMeshRegions -cellZones -overwrite # remove fluid fields from solid regions (important for post-processing) for i in heater leftSolid rightSolid do - rm -f 0*/$i/{rho,nut,alphat,epsilon,k,U,p_rgh,Qr,G,IDefault} + rm -f 0*/$i/{rho,nut,alphat,epsilon,k,U,p_rgh,qr,G,IDefault} done for i in bottomAir topAir heater leftSolid rightSolid diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict index e49858a25bd0288f79be55085f673f93def8e426..7be44a3a52fc9ab5dd23dfeb430c8d6b8fe425a9 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/changeDictionaryDict @@ -54,8 +54,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod fluidThermo; - QrNbr none; - Qr Qr; + qrNbr none; + qr qr; value uniform 300; } } @@ -113,7 +113,7 @@ p } } -Qr +qr { internalField uniform 0; boundaryField @@ -122,7 +122,7 @@ Qr { type greyDiffusiveRadiationViewFactor; emissivityMode lookup; - Qro uniform 0; + qro uniform 0; emissivity uniform 1.0; value uniform 0; } @@ -131,7 +131,7 @@ Qr { type greyDiffusiveRadiationViewFactor; emissivityMode solidRadiation; - Qro uniform 0; + qro uniform 0; value uniform 0; } } diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution index 2f353374cdcebe05c339674695d1313b590f1ccf..e4ba12e773c7ded9610f68f77e5fec2403fb12bc 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/bottomAir/fvSolution @@ -74,7 +74,7 @@ relaxationFactors "(k|epsilon|omega)" 0.7; G 0.7; "ILambda.*" 0.7; - Qr 0.7; + qr 0.7; } } diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict index d654d223718799b481ff6f45383e6d6a38c4ca3b..d27d0cbf24b0d8bddf4d66213e15c4e1aced41ab 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/heater/changeDictionaryDict @@ -47,8 +47,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; value uniform 300; } @@ -57,8 +57,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; value uniform 300; } diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict index 8cda0f66e009e91f3545bdbc79e1a58921b8a239..a22671d9cd06b70f855a6e0180f590dbc33dbf00 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/changeDictionaryDict @@ -43,8 +43,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; value uniform 300; } @@ -53,8 +53,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; value uniform 300; } diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict index a6a455047ce05169a5eca02b5a445de673ce6c7c..039be56e01d09edbcbc22582f6c004f119a28a92 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/changeDictionaryDict @@ -43,8 +43,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; value uniform 300; } @@ -53,8 +53,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod solidThermo; - QrNbr Qr; - Qr none; + qrNbr qr; + qr none; value uniform 300; } diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict index 81d906dbd9b5537612f3bf1d89b9ebcb7296721c..81ef8f2f7ea43eb3f0edd1c1b9e338ddfd071be3 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/changeDictionaryDict @@ -65,8 +65,8 @@ T type compressible::turbulentTemperatureRadCoupledMixed; Tnbr T; kappaMethod fluidThermo; - QrNbr none; - Qr Qr; + qrNbr none; + qr qr; value uniform 300; } } @@ -160,7 +160,7 @@ p } } -Qr +qr { internalField uniform 0; boundaryField @@ -169,7 +169,7 @@ Qr { type greyDiffusiveRadiationViewFactor; emissivityMode lookup; - Qro uniform 0; + qro uniform 0; emissivity uniform 1.0; value uniform 0; } @@ -178,7 +178,7 @@ Qr { type greyDiffusiveRadiationViewFactor; emissivityMode solidRadiation; - Qro uniform 0; + qro uniform 0; value uniform 0; } } diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution index 2f353374cdcebe05c339674695d1313b590f1ccf..e4ba12e773c7ded9610f68f77e5fec2403fb12bc 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution @@ -74,7 +74,7 @@ relaxationFactors "(k|epsilon|omega)" 0.7; G 0.7; "ILambda.*" 0.7; - Qr 0.7; + qr 0.7; } }