diff --git a/applications/solvers/combustion/chemFoam/solveChemistry.H b/applications/solvers/combustion/chemFoam/solveChemistry.H index daf56309bd3221a9f552d9c811d33a513258307b..cb4258c31df34b4c78aff3462226c21d815e3c29 100644 --- a/applications/solvers/combustion/chemFoam/solveChemistry.H +++ b/applications/solvers/combustion/chemFoam/solveChemistry.H @@ -1,7 +1,3 @@ - dtChem = chemistry.solve - ( - runTime.value() - runTime.deltaT().value(), - runTime.deltaT().value() - ); + dtChem = chemistry.solve(runTime.deltaT().value()); scalar Sh = chemistry.Sh()()[0]/rho[0]; integratedHeat += Sh*runTime.deltaT().value(); diff --git a/applications/solvers/combustion/reactingFoam/EEqn.H b/applications/solvers/combustion/reactingFoam/EEqn.H index 56ddf867e796f60086400e0a8e65125aafe6117e..9267c9a9bef16e0d1af88b81db2df8bba7c2442a 100644 --- a/applications/solvers/combustion/reactingFoam/EEqn.H +++ b/applications/solvers/combustion/reactingFoam/EEqn.H @@ -16,7 +16,6 @@ : -dpdt ) - fvm::laplacian(turbulence->alphaEff(), he) -// - fvm::laplacian(turbulence->muEff(), he) // unit lewis no. == reaction->Sh() + fvOptions(rho, he) diff --git a/applications/solvers/combustion/reactingFoam/LTSReactingFoam/LTSReactingFoam.C b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/LTSReactingFoam.C new file mode 100644 index 0000000000000000000000000000000000000000..0b34210865f87a91c78d489ea0a9dd71d83b448f --- /dev/null +++ b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/LTSReactingFoam.C @@ -0,0 +1,107 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2013 OpenFOAM Foundation + \\/ 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 3 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, see <http://www.gnu.org/licenses/>. + +Application + LTSReactingFoam + +Description + Local time stepping (LTS) solver for steady, compressible, laminar or + turbulent reacting and non-reacting flow. + +\*---------------------------------------------------------------------------*/ + +#include "fvCFD.H" +#include "turbulenceModel.H" +#include "psiCombustionModel.H" +#include "multivariateScheme.H" +#include "pimpleControl.H" +#include "fvIOoptionList.H" +#include "fvcSmooth.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +int main(int argc, char *argv[]) +{ + #include "setRootCase.H" + #include "createTime.H" + #include "createMesh.H" + + pimpleControl pimple(mesh); + + #include "readGravitationalAcceleration.H" + #include "createFields.H" + #include "createFvOptions.H" + #include "initContinuityErrs.H" + #include "readTimeControls.H" + #include "compressibleCourantNo.H" + #include "setInitialrDeltaT.H" + + // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + + Info<< "\nStarting time loop\n" << endl; + + while (runTime.run()) + { + #include "readTimeControls.H" + + runTime++; + + Info<< "Time = " << runTime.timeName() << nl << endl; + + #include "setrDeltaT.H" + + #include "rhoEqn.H" + + // --- Pressure-velocity PIMPLE corrector loop + while (pimple.loop()) + { + #include "UEqn.H" + #include "YEqn.H" + #include "EEqn.H" + + // --- Pressure corrector loop + while (pimple.correct()) + { + #include "pEqn.H" + } + + if (pimple.turbCorr()) + { + turbulence->correct(); + } + } + + runTime.write(); + + Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" + << " ClockTime = " << runTime.elapsedClockTime() << " s" + << nl << endl; + } + + Info<< "End\n" << endl; + + return(0); +} + + +// ************************************************************************* // diff --git a/applications/solvers/combustion/reactingFoam/LTSReactingFoam/Make/files b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/Make/files new file mode 100644 index 0000000000000000000000000000000000000000..0b81e7a03247e0f362b71cc12cee85fd0c9f134e --- /dev/null +++ b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/Make/files @@ -0,0 +1,3 @@ +LTSReactingFoam.C + +EXE = $(FOAM_APPBIN)/LTSReactingFoam diff --git a/applications/solvers/combustion/reactingFoam/LTSReactingFoam/Make/options b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/Make/options new file mode 100644 index 0000000000000000000000000000000000000000..abac9d96a4c1da64039dd6e1c09b4b6e7ad4fbcc --- /dev/null +++ b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/Make/options @@ -0,0 +1,28 @@ +EXE_INC = -ggdb3 \ + -I.. \ + -I$(LIB_SRC)/finiteVolume/lnInclude \ + -I$(LIB_SRC)/fvOptions/lnInclude \ + -I$(LIB_SRC)/meshTools/lnInclude \ + -I$(LIB_SRC)/sampling/lnInclude \ + -I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel \ + -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \ + -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \ + -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ + -I$(LIB_SRC)/thermophysicalModels/chemistryModel/lnInclude \ + -I$(LIB_SRC)/ODE/lnInclude \ + -I$(LIB_SRC)/combustionModels/lnInclude + +EXE_LIBS = \ + -lfiniteVolume \ + -lfvOptions \ + -lmeshTools \ + -lsampling \ + -lcompressibleTurbulenceModel \ + -lcompressibleRASModels \ + -lcompressibleLESModels \ + -lreactionThermophysicalModels \ + -lspecie \ + -lfluidThermophysicalModels \ + -lchemistryModel \ + -lODE \ + -lcombustionModels diff --git a/applications/solvers/combustion/reactingFoam/LTSReactingFoam/readTimeControls.H b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/readTimeControls.H new file mode 100644 index 0000000000000000000000000000000000000000..2a6dd6f3456c2d7659e05ba931e63cf18b9e790b --- /dev/null +++ b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/readTimeControls.H @@ -0,0 +1,48 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2013 OpenFOAM Foundation + \\/ 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 3 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, see <http://www.gnu.org/licenses/>. + +\*---------------------------------------------------------------------------*/ + +// Maximum flow Courant number +scalar maxCo(readScalar(pimple.dict().lookup("maxCo"))); + +// Maximum time scale +scalar maxDeltaT(pimple.dict().lookupOrDefault<scalar>("maxDeltaT", GREAT)); + +// Smoothing parameter (0-1) when smoothing iterations > 0 +scalar rDeltaTSmoothingCoeff +( + pimple.dict().lookupOrDefault<scalar>("rDeltaTSmoothingCoeff", 0.1) +); + +// Damping coefficient (1-0) +scalar rDeltaTDampingCoeff +( + pimple.dict().lookupOrDefault<scalar>("rDeltaTDampingCoeff", 1.0) +); + +// Maximum change in cell temperature per iteration (relative to previous value) +scalar alphaTemp(pimple.dict().lookupOrDefault("alphaTemp", 0.5)); + + +// ************************************************************************* // diff --git a/applications/solvers/combustion/reactingFoam/LTSReactingFoam/setInitialrDeltaT.H b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/setInitialrDeltaT.H new file mode 100644 index 0000000000000000000000000000000000000000..c445eaee71e69d203e425df155dfa058ea71a170 --- /dev/null +++ b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/setInitialrDeltaT.H @@ -0,0 +1,14 @@ + volScalarField rDeltaT + ( + IOobject + ( + "rDeltaT", + runTime.timeName(), + mesh, + IOobject::READ_IF_PRESENT, + IOobject::AUTO_WRITE + ), + mesh, + dimensionedScalar("one", dimless/dimTime, 1), + zeroGradientFvPatchScalarField::typeName + ); diff --git a/applications/solvers/combustion/reactingFoam/LTSReactingFoam/setrDeltaT.H b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/setrDeltaT.H new file mode 100644 index 0000000000000000000000000000000000000000..ce1caf1de5eec3efdde8b9365ad0e96a4b866dbe --- /dev/null +++ b/applications/solvers/combustion/reactingFoam/LTSReactingFoam/setrDeltaT.H @@ -0,0 +1,97 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2013 OpenFOAM Foundation + \\/ 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 3 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, see <http://www.gnu.org/licenses/>. + +\*---------------------------------------------------------------------------*/ + +{ + Info<< "Time scales min/max:" << endl; + + // Cache old reciprocal time scale field + volScalarField rDeltaT0("rDeltaT0", rDeltaT); + + // Flow time scale + { + rDeltaT.dimensionedInternalField() = + ( + fvc::surfaceSum(mag(phi))().dimensionedInternalField() + /((2*maxCo)*mesh.V()*rho.dimensionedInternalField()) + ); + + // Limit the largest time scale + rDeltaT.max(1/maxDeltaT); + + Info<< " Flow = " + << gMin(1/rDeltaT.internalField()) << ", " + << gMax(1/rDeltaT.internalField()) << endl; + } + + // Reaction source time scale + if (alphaTemp < 1.0) + { + volScalarField::DimensionedInternalField rDeltaTT + ( + mag(reaction->Sh())/(alphaTemp*rho*thermo.Cp()*T) + ); + + Info<< " Temperature = " + << gMin(1/(rDeltaTT.field() + VSMALL)) << ", " + << gMax(1/(rDeltaTT.field() + VSMALL)) << endl; + + rDeltaT.dimensionedInternalField() = max + ( + rDeltaT.dimensionedInternalField(), + rDeltaTT + ); + } + + // Update tho boundary values of the reciprocal time-step + rDeltaT.correctBoundaryConditions(); + + // Spatially smooth the time scale field + if (rDeltaTSmoothingCoeff < 1.0) + { + fvc::smooth(rDeltaT, rDeltaTSmoothingCoeff); + } + + // Limit rate of change of time scale + // - reduce as much as required + // - only increase at a fraction of old time scale + if + ( + rDeltaTDampingCoeff < 1.0 + && runTime.timeIndex() > runTime.startTimeIndex() + 1 + ) + { + rDeltaT = max + ( + rDeltaT, + (scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0 + ); + } + + Info<< " Overall = " + << gMin(1/rDeltaT.internalField()) + << ", " << gMax(1/rDeltaT.internalField()) << endl; +} + +// ************************************************************************* // diff --git a/applications/solvers/multiphase/interFoam/LTSInterFoam/setrDeltaT.H b/applications/solvers/multiphase/interFoam/LTSInterFoam/setrDeltaT.H index f419153506c1ef5962aad3693546bf00ee6a8ae1..3f8ba982cf9c644a203541499d90fd9aa7f51520 100644 --- a/applications/solvers/multiphase/interFoam/LTSInterFoam/setrDeltaT.H +++ b/applications/solvers/multiphase/interFoam/LTSInterFoam/setrDeltaT.H @@ -121,9 +121,11 @@ && runTime.timeIndex() > runTime.startTimeIndex() + 1 ) { - rDeltaT = - rDeltaT0 - *max(rDeltaT/rDeltaT0, scalar(1.0) - rDeltaTDampingCoeff); + rDeltaT = max + ( + rDeltaT, + (scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0 + ); Info<< "Damped flow time scale min/max = " << gMin(1/rDeltaT.internalField()) diff --git a/applications/utilities/mesh/generation/Allwmake b/applications/utilities/mesh/generation/Allwmake new file mode 100755 index 0000000000000000000000000000000000000000..8f7cbada96f19024e7dd4cf17a0f27b20b491642 --- /dev/null +++ b/applications/utilities/mesh/generation/Allwmake @@ -0,0 +1,18 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # run from this directory +set -x + +wmake all blockMesh +wmake all extrude +wmake all extrude2DMesh +wmake all snappyHexMesh + +if [ -d "$CGAL_ARCH_PATH" ] +then + wmake libso foamyHexMesh/conformalVoronoiMesh + wmake all foamyHexMesh + wmake all foamyQuadMesh +fi + + +# ----------------------------------------------------------------- end-of-file diff --git a/applications/utilities/mesh/generation/foamyQuadMesh/Allwmake b/applications/utilities/mesh/generation/foamyQuadMesh/Allwmake index 3620addd3867aa8d701752e72e2255c869d12a49..18fc1e952a39176f210b53f0c88d3e1f514d621d 100755 --- a/applications/utilities/mesh/generation/foamyQuadMesh/Allwmake +++ b/applications/utilities/mesh/generation/foamyQuadMesh/Allwmake @@ -4,7 +4,9 @@ set -x if [ -d "$CGAL_ARCH_PATH" ] then - wmake libso ../foamyHexMesh/conformalVoronoiMesh + #- Already built by ../Allwake + #wmake libso ../foamyHexMesh/conformalVoronoiMesh + wmake libso conformalVoronoi2DMesh wmake fi diff --git a/src/combustionModels/Make/files b/src/combustionModels/Make/files index 88e81afe8bc55174ae2d5a686b5f298781ecded3..b68fbb742f273498a2ad7a76f0436b7d665aa45e 100644 --- a/src/combustionModels/Make/files +++ b/src/combustionModels/Make/files @@ -15,6 +15,8 @@ infinitelyFastChemistry/infinitelyFastChemistrys.C PaSR/PaSRs.C +laminar/laminars.C + FSD/reactionRateFlameAreaModels/consumptionSpeed/consumptionSpeed.C FSD/reactionRateFlameAreaModels/reactionRateFlameArea/reactionRateFlameArea.C FSD/reactionRateFlameAreaModels/reactionRateFlameArea/reactionRateFlameAreaNew.C @@ -25,4 +27,3 @@ FSD/FSDs.C noCombustion/noCombustions.C LIB = $(FOAM_LIBBIN)/libcombustionModels - diff --git a/src/combustionModels/PaSR/PaSR.C b/src/combustionModels/PaSR/PaSR.C index 8cf2f031719f96f5b59fef7eb628dd507805125e..14ae46a1121d9d9b3fb92df5d3da4730777556ec 100644 --- a/src/combustionModels/PaSR/PaSR.C +++ b/src/combustionModels/PaSR/PaSR.C @@ -51,11 +51,18 @@ Foam::combustionModels::PaSR<Type>::PaSR mesh, dimensionedScalar("kappa", dimless, 0.0) ), - useReactionRate_(this->coeffs().lookupOrDefault("useReactionRate", false)) + integrateReactionRate_ + ( + this->coeffs().lookupOrDefault("integrateReactionRate", true) + ) { - if (useReactionRate_) + if (integrateReactionRate_) { - Info<< " using reaction rate" << endl; + Info<< " using integrated reaction rate" << endl; + } + else + { + Info<< " using instantaneous reaction rate" << endl; } } @@ -81,12 +88,11 @@ void Foam::combustionModels::PaSR<Type>::correct() { if (this->active()) { - const scalar t = this->mesh().time().value(); const scalar dt = this->mesh().time().deltaTValue(); - if (!useReactionRate_) + if (integrateReactionRate_) { - this->chemistryPtr_->solve(t - dt, dt); + this->chemistryPtr_->solve(dt); } else { @@ -107,24 +113,15 @@ void Foam::combustionModels::PaSR<Type>::correct() forAll(epsilon, i) { - if (epsilon[i] > 0) + scalar tk = + Cmix_*Foam::sqrt(muEff[i]/rho[i]/(epsilon[i] + SMALL)); + + if (tk > SMALL) { - scalar tk = - Cmix_*Foam::sqrt(muEff[i]/rho[i]/(epsilon[i] + SMALL)); - - // Chalmers PaSR model - if (!useReactionRate_) - { - kappa_[i] = (dt + tc[i])/(dt + tc[i] + tk); - } - else - { - kappa_[i] = tc[i]/(tc[i] + tk); - } + kappa_[i] = tc[i]/(tc[i] + tk); } else { - // Return to laminar combustion kappa_[i] = 1.0; } } @@ -229,7 +226,8 @@ bool Foam::combustionModels::PaSR<Type>::read() { this->coeffs().lookup("Cmix") >> Cmix_; this->coeffs().lookup("turbulentReaction") >> turbulentReaction_; - this->coeffs().lookup("useReactionRate") >> useReactionRate_; + this->coeffs().lookup("integrateReactionRate") + >> integrateReactionRate_; return true; } else diff --git a/src/combustionModels/PaSR/PaSR.H b/src/combustionModels/PaSR/PaSR.H index fa6c73eb955715e68c45f5a7f45762f176e07584..5b4c8d608194fc8a36bfe17c7e4f036d78e3300e 100644 --- a/src/combustionModels/PaSR/PaSR.H +++ b/src/combustionModels/PaSR/PaSR.H @@ -65,8 +65,9 @@ class PaSR //- Mixing parameter volScalarField kappa_; - //- Use reaction rate - bool useReactionRate_; + //- Integrate reaction rate over the time-step + // using the selected ODE solver + bool integrateReactionRate_; // Private Member Functions diff --git a/src/combustionModels/laminar/laminar.C b/src/combustionModels/laminar/laminar.C new file mode 100644 index 0000000000000000000000000000000000000000..b7a40921e90e8c68957930d8f2c1cbd275ef7702 --- /dev/null +++ b/src/combustionModels/laminar/laminar.C @@ -0,0 +1,188 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2013 OpenFOAM Foundation + \\/ 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 3 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, see <http://www.gnu.org/licenses/>. + +\*---------------------------------------------------------------------------*/ + +#include "laminar.H" +#include "fvmSup.H" + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +template<class Type> +Foam::combustionModels::laminar<Type>::laminar +( + const word& modelType, + const fvMesh& mesh +) +: + Type(modelType, mesh), + integrateReactionRate_ + ( + this->coeffs().lookupOrDefault("integrateReactionRate", true) + ) +{ + if (integrateReactionRate_) + { + Info<< " using integrated reaction rate" << endl; + } + else + { + Info<< " using instantaneous reaction rate" << endl; + } +} + + +// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // + +template<class Type> +Foam::combustionModels::laminar<Type>::~laminar() +{} + + +// * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * // + +template<class Type> +Foam::tmp<Foam::volScalarField> +Foam::combustionModels::laminar<Type>::tc() const +{ + return this->chemistryPtr_->tc(); +} + + +template<class Type> +void Foam::combustionModels::laminar<Type>::correct() +{ + if (this->active()) + { + if (integrateReactionRate_) + { + this->chemistryPtr_->solve(this->mesh().time().deltaTValue()); + } + else + { + this->chemistryPtr_->calculate(); + } + } +} + + +template<class Type> +Foam::tmp<Foam::fvScalarMatrix> +Foam::combustionModels::laminar<Type>::R(volScalarField& Y) const +{ + tmp<fvScalarMatrix> tSu(new fvScalarMatrix(Y, dimMass/dimTime)); + + fvScalarMatrix& Su = tSu(); + + if (this->active()) + { + const label specieI = this->thermo().composition().species()[Y.name()]; + + Su += this->chemistryPtr_->RR(specieI); + } + + return tSu; +} + + +template<class Type> +Foam::tmp<Foam::volScalarField> +Foam::combustionModels::laminar<Type>::dQ() const +{ + tmp<volScalarField> tdQ + ( + new volScalarField + ( + IOobject + ( + typeName + ":dQ", + this->mesh().time().timeName(), + this->mesh(), + IOobject::NO_READ, + IOobject::NO_WRITE, + false + ), + this->mesh(), + dimensionedScalar("dQ", dimEnergy/dimTime, 0.0), + zeroGradientFvPatchScalarField::typeName + ) + ); + + if (this->active()) + { + tdQ() = this->chemistryPtr_->dQ(); + } + + return tdQ; +} + + +template<class Type> +Foam::tmp<Foam::volScalarField> +Foam::combustionModels::laminar<Type>::Sh() const +{ + tmp<volScalarField> tSh + ( + new volScalarField + ( + IOobject + ( + typeName + ":Sh", + this->mesh().time().timeName(), + this->mesh(), + IOobject::NO_READ, + IOobject::NO_WRITE, + false + ), + this->mesh(), + dimensionedScalar("zero", dimEnergy/dimTime/dimVolume, 0.0), + zeroGradientFvPatchScalarField::typeName + ) + ); + + if (this->active()) + { + tSh() = this->chemistryPtr_->Sh(); + } + + return tSh; +} + + +template<class Type> +bool Foam::combustionModels::laminar<Type>::read() +{ + if (Type::read()) + { + this->coeffs().lookup("integrateReactionRate") + >> integrateReactionRate_; + return true; + } + else + { + return false; + } +} + + +// ************************************************************************* // diff --git a/src/combustionModels/laminar/laminar.H b/src/combustionModels/laminar/laminar.H new file mode 100644 index 0000000000000000000000000000000000000000..25e086d81c45544c5d0808bd04b4b5cd68f5bed5 --- /dev/null +++ b/src/combustionModels/laminar/laminar.H @@ -0,0 +1,128 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2013 OpenFOAM Foundation + \\/ 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 3 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, see <http://www.gnu.org/licenses/>. + +Class + Foam::combustionModels::laminar + +Description + Laminar combustion model. + +SourceFiles + laminar.C + +\*---------------------------------------------------------------------------*/ + +#ifndef laminar_H +#define laminar_H + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ +namespace combustionModels +{ + +/*---------------------------------------------------------------------------*\ + Class laminar Declaration +\*---------------------------------------------------------------------------*/ + +template<class Type> +class laminar +: + public Type +{ + // Private data + + //- Integrate reaction rate over the time-step + // using the selected ODE solver + bool integrateReactionRate_; + + + // Private Member Functions + + //- Return the chemical time scale + tmp<volScalarField> tc() const; + + //- Disallow copy construct + laminar(const laminar&); + + //- Disallow default bitwise assignment + void operator=(const laminar&); + + +public: + + //- Runtime type information + TypeName("laminar"); + + + // Constructors + + //- Construct from components + laminar(const word& modelType, const fvMesh& mesh); + + + //- Destructor + virtual ~laminar(); + + + // Member Functions + + // Evolution + + //- Correct combustion rate + virtual void correct(); + + //- Fuel consumption rate matrix. + virtual tmp<fvScalarMatrix> R(volScalarField& Y) const; + + //- Heat release rate calculated from fuel consumption rate matrix + virtual tmp<volScalarField> dQ() const; + + //- Return source for enthalpy equation [kg/m/s3] + virtual tmp<volScalarField> Sh() const; + + + // I-O + + //- Update properties from given dictionary + virtual bool read(); +}; + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace combustionModels +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#ifdef NoRepository +# include "laminar.C" +#endif + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/src/combustionModels/laminar/laminars.C b/src/combustionModels/laminar/laminars.C new file mode 100644 index 0000000000000000000000000000000000000000..1c7d5526c9e9ad8aa4e5bd5434d99b91edc2efcb --- /dev/null +++ b/src/combustionModels/laminar/laminars.C @@ -0,0 +1,44 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2013 OpenFOAM Foundation + \\/ 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 3 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, see <http://www.gnu.org/licenses/>. + +\*---------------------------------------------------------------------------*/ + +#include "makeCombustionTypes.H" + +#include "psiChemistryCombustion.H" +#include "rhoChemistryCombustion.H" +#include "laminar.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ +namespace combustionModels +{ + makeCombustionTypes(laminar, psiChemistryCombustion, psiCombustionModel); + makeCombustionTypes(laminar, rhoChemistryCombustion, rhoCombustionModel); +} +} + + +// ************************************************************************* // diff --git a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C index 1e6a30627e609b7f28bd6f6ba4a04110c77849a9..b98417e52aebbed6a61f0b6ff8dffa92f9bb83fc 100644 --- a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C +++ b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C @@ -691,11 +691,7 @@ void reactingOneDim::evolveRegion() if (useChemistrySolvers_) { - solidChemistry_->solve - ( - time().value() - time().deltaTValue(), - time().deltaTValue() - ); + solidChemistry_->solve(time().deltaTValue()); } else { diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/basicChemistryModel/basicChemistryModel.H b/src/thermophysicalModels/chemistryModel/chemistryModel/basicChemistryModel/basicChemistryModel.H index 75ea14eb676ac1a4f84508c8108b7643b823c30a..f7143df63f1272d185cd36138e4cb567e1b14b0a 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/basicChemistryModel/basicChemistryModel.H +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/basicChemistryModel/basicChemistryModel.H @@ -152,9 +152,9 @@ public: //- Calculates the reaction rates virtual void calculate() = 0; - //- Solve the reaction system for the given start time and - // timestep and return the characteristic time - virtual scalar solve(const scalar t0, const scalar deltaT) = 0; + //- Solve the reaction system for the given time step + // and return the characteristic time + virtual scalar solve(const scalar deltaT) = 0; //- Return the chemical time scale virtual tmp<volScalarField> tc() const = 0; diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C index f23a80b6ef30404388ac8a3c5cccfc5e2fa0dcf7..098083b6fdb59989e2f8e7688ed99d79eb62d545 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C @@ -744,7 +744,6 @@ void Foam::chemistryModel<CompType, ThermoType>::calculate() template<class CompType, class ThermoType> Foam::scalar Foam::chemistryModel<CompType, ThermoType>::solve ( - const scalar t0, const scalar deltaT ) { @@ -795,7 +794,7 @@ Foam::scalar Foam::chemistryModel<CompType, ThermoType>::solve c0 = c; // initialise timing parameters - scalar t = t0; + scalar t = 0; scalar tauC = this->deltaTChem_[celli]; scalar dt = min(deltaT, tauC); scalar timeLeft = deltaT; diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.H b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.H index 475fc7c8fd77f89ec249d4878d651ba05d456413..232855d620878dbbaa234ef5eee1ca6cc58aae6f 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.H +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.H @@ -217,9 +217,9 @@ public: const label i ); - //- Solve the reaction system for the given start time and time - // step and return the characteristic time - virtual scalar solve(const scalar t0, const scalar deltaT); + //- Solve the reaction system for the given time step + // and return the characteristic time + virtual scalar solve(const scalar deltaT); //- Return the chemical time scale virtual tmp<volScalarField> tc() const; diff --git a/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C b/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C index 4962bf716b6b5a34079b44e0db1fdee361f30913..f5cb38648bab3d6310f2e96e771c8d158deb8df2 100644 --- a/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C +++ b/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C @@ -580,7 +580,6 @@ template<class CompType, class SolidThermo, class GasThermo> Foam::scalar Foam::pyrolysisChemistryModel<CompType, SolidThermo, GasThermo>::solve ( - const scalar t0, const scalar deltaT ) { @@ -638,7 +637,7 @@ Foam::pyrolysisChemistryModel<CompType, SolidThermo, GasThermo>::solve c0 = c; - scalar t = t0; + scalar t = 0; scalar tauC = this->deltaTChem_[celli]; scalar dt = min(deltaT, tauC); scalar timeLeft = deltaT; diff --git a/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.H b/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.H index 7ae76c5233383221b14539d5b092439617b8c299..fd82b4d09a88c8c03ebc17d2bf69e665344e825d 100644 --- a/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.H +++ b/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.H @@ -224,9 +224,9 @@ public: const label i ) const; - //- Solve the reaction system for the given start time and time - // step and return the characteristic time - virtual scalar solve(const scalar t0, const scalar deltaT) ; + //- Solve the reaction system for the given time step + // and return the characteristic time + virtual scalar solve(const scalar deltaT); // ODE functions (overriding abstract functions in ODE.H) diff --git a/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.H b/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.H index bf67f1ca4d27c9662c29369d68d724b1aa854366..93a6833250c5663c7d30f8f33a91e6e514b44a55 100644 --- a/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.H +++ b/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.H @@ -214,9 +214,9 @@ public: //- Return total solid source term inline tmp<DimensionedField<scalar, volMesh> > RRs() const; - //- Solve the reaction system for the given start time and time - // step and return the characteristic time - virtual scalar solve(const scalar t0, const scalar deltaT) = 0; + //- Solve the reaction system for the given time step + // and return the characteristic time + virtual scalar solve(const scalar deltaT) = 0; //- Return the chemical time scale virtual tmp<volScalarField> tc() const; diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/CH4 b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/CH4 new file mode 100644 index 0000000000000000000000000000000000000000..15dd5eddf1636eec4cbfa1925991bfcb2ad39311 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/CH4 @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object CH4; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0.0; + +boundaryField +{ + fuel + { + type fixedValue; + value uniform 1.0; + } + air + { + type fixedValue; + value uniform 0.0; + } + outlet + { + type inletOutlet; + inletValue uniform 0.0; + value uniform 0.0; + + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/epsilon b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/CO2 similarity index 80% rename from tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/epsilon rename to tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/CO2 index ad65f7ea0f6c17466d257766119788312e8f6a5f..2fef379ec761a9a98aec2cce70b70f25f08d8d68 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/epsilon +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/CO2 @@ -11,29 +11,32 @@ FoamFile format ascii; class volScalarField; location "0"; - object epsilon; + object CO2; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [0 2 -3 0 0 0 0]; +dimensions [0 0 0 0 0 0 0]; -internalField uniform 50; +internalField uniform 0; boundaryField { fuel { type fixedValue; - value uniform 1e-05; + value uniform 0; } air { type fixedValue; - value uniform 1e-05; + value uniform 0; } outlet { - type zeroGradient; + type inletOutlet; + inletValue uniform 0; + value uniform 0; + } frontAndBack { diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/k b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/H2O similarity index 80% rename from tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/k rename to tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/H2O index 3dcedaa2da47fbd55ebfcc30f215485dddfb92e8..ca2273563064fa528f36a9e642e4fe90a1126376 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/k +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/H2O @@ -11,29 +11,32 @@ FoamFile format ascii; class volScalarField; location "0"; - object k; + object H2O; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [0 2 -2 0 0 0 0]; +dimensions [0 0 0 0 0 0 0]; -internalField uniform 3.75e-05; +internalField uniform 0; boundaryField { fuel { type fixedValue; - value uniform 3.75e-05; + value uniform 0; } air { type fixedValue; - value uniform 3.75e-05; + value uniform 0; } outlet { - type zeroGradient; + type inletOutlet; + inletValue uniform 0; + value uniform 0; + } frontAndBack { diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/N2 b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/N2 new file mode 100644 index 0000000000000000000000000000000000000000..8b2b2e8b5d70e7f60086d068a719c3c8287e1c75 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/N2 @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object O2; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 1; + +boundaryField +{ + fuel + { + type fixedValue; + value uniform 0.0; + } + air + { + type fixedValue; + value uniform 0.77; + } + outlet + { + type inletOutlet; + inletValue uniform 1; + value uniform 1; + + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/rho b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/O2 similarity index 74% rename from tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/rho rename to tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/O2 index d1620aaeb0f3a55fe44b3a2a1d7cd51cadcfbb71..95649fdac4d49cfb0bf4c106761a3d7835c25504 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/rho +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/O2 @@ -11,30 +11,31 @@ FoamFile format ascii; class volScalarField; location "0"; - object rho; + object O2; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [1 -3 0 0 0 0 0]; +dimensions [0 0 0 0 0 0 0]; -internalField uniform 1.18001; +internalField uniform 0; boundaryField { fuel { - type calculated; - value uniform 0.243121; + type fixedValue; + value uniform 0.0; } air { - type calculated; - value uniform 0.438564; + type fixedValue; + value uniform 0.23; } outlet { - type calculated; - value uniform 1.18001; + type inletOutlet; + inletValue uniform 0; + value uniform 0; } frontAndBack { diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/T b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/T new file mode 100644 index 0000000000000000000000000000000000000000..fcf963a775b0fe6baa6f1e1be87fa9f52ba82eda --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/T @@ -0,0 +1,47 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object T; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 1 0 0 0]; + +internalField uniform 293; + +boundaryField +{ + fuel + { + type fixedValue; + value uniform 800; + } + air + { + type fixedValue; + value uniform 800; + } + outlet + { + type inletOutlet; + inletValue uniform 293; + value uniform 293; + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/U b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/U new file mode 100644 index 0000000000000000000000000000000000000000..c235ba3d6599d2ee0addf202f46971a86b27b928 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/U @@ -0,0 +1,46 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object U; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + fuel + { + type fixedValue; + value uniform (0.1 0 0); + } + air + { + type fixedValue; + value uniform (-0.1 0 0); + } + outlet + { + type pressureInletOutletVelocity; + value $internalField; + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/Ydefault b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/Ydefault new file mode 100644 index 0000000000000000000000000000000000000000..96004af717f654335a5de7623b30a6415b42542b --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/Ydefault @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object Ydefault; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0.0; + +boundaryField +{ + fuel + { + type fixedValue; + value uniform 0.0; + } + air + { + type fixedValue; + value uniform 0.0; + } + outlet + { + type inletOutlet; + inletValue uniform 0.0; + value uniform 0.0; + + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/mut b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/alphat similarity index 98% rename from tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/mut rename to tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/alphat index 47d65d567db19cb35dfe8637deebe525d1bd7580..c74018bbdb33b027d8c9098fc95a61eae2024749 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/mut +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/alphat @@ -11,7 +11,7 @@ FoamFile format ascii; class volScalarField; location "0"; - object mut; + object alphat; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/p b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/p new file mode 100644 index 0000000000000000000000000000000000000000..deca9ba60da613c61097d7624095469169b50c65 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/0/p @@ -0,0 +1,50 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + location "0"; + object p; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 1e5; + +boundaryField +{ + fuel + { + type zeroGradient; + } + air + { + type zeroGradient; + } + outlet + { + type totalPressure; + p0 $internalField; + U U; + phi phi; + rho none; + psi none; + gamma 1; + value $internalField; + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/chemistryProperties b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/chemistryProperties new file mode 100644 index 0000000000000000000000000000000000000000..9c005101238147b75907e9bf44fd74699daefbbc --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/chemistryProperties @@ -0,0 +1,46 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object chemistryProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +chemistryType +{ + chemistrySolver ode; + chemistryThermo psi; +} + +chemistry on; + +initialChemicalTimeStep 1e-07; + +sequentialCoeffs +{ + cTauChem 0.001; +} + +EulerImplicitCoeffs +{ + cTauChem 0.05; + equilibriumRateLimiter off; +} + +odeCoeffs +{ + solver KRR4; + eps 0.05; + scale 1; +} + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/combustionProperties b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/combustionProperties new file mode 100644 index 0000000000000000000000000000000000000000..d5c12209c1dac6c3e38c74191d14bc79977d6b3b --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/combustionProperties @@ -0,0 +1,27 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object combustionProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +combustionModel laminar<psiChemistryCombustion>; + +active true; + +laminarCoeffs +{ +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/g b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/g new file mode 100644 index 0000000000000000000000000000000000000000..057403310a4dba8dc69f1470dd26d8a7d6d6b978 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/g @@ -0,0 +1,22 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class uniformDimensionedVectorField; + location "constant"; + object g; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -2 0 0 0 0]; +value ( 0 0 0 ); + + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/polyMesh/blockMeshDict b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/polyMesh/blockMeshDict new file mode 100644 index 0000000000000000000000000000000000000000..3683ab33882557a8a1dda26ddb4ca3213da69c25 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/polyMesh/blockMeshDict @@ -0,0 +1,82 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object blockMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +convertToMeters 1; + +vertices +( + (0.0 -0.01 -0.01) + (0.02 -0.01 -0.01) + (0.02 0.01 -0.01) + (0.0 0.01 -0.01) + (0.0 -0.01 0.01) + (0.02 -0.01 0.01) + (0.02 0.01 0.01) + (0.0 0.01 0.01) +); + +blocks +( + hex (0 1 2 3 4 5 6 7) (100 40 1) simpleGrading (1 1 1) +); + +edges +( +); + +boundary +( + fuel + { + type patch; + faces + ( + (0 4 7 3) + ); + } + air + { + type patch; + faces + ( + (1 2 6 5) + ); + } + outlet + { + type patch; + faces + ( + (0 1 5 4) + (7 6 2 3) + ); + } + frontAndBack + { + type empty; + faces + ( + (4 5 6 7) + (0 3 2 1) + ); + } +); + +mergePatchPairs +( +); + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/polyMesh/boundary b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/polyMesh/boundary new file mode 100644 index 0000000000000000000000000000000000000000..4ba324347484fa7620b2ac2ca118f030cf3166de --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/polyMesh/boundary @@ -0,0 +1,47 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class polyBoundaryMesh; + location "constant/polyMesh"; + object boundary; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +4 +( + fuel + { + type patch; + nFaces 40; + startFace 7860; + } + air + { + type patch; + nFaces 40; + startFace 7900; + } + outlet + { + type patch; + nFaces 200; + startFace 7940; + } + frontAndBack + { + type empty; + inGroups 1(empty); + nFaces 8000; + startFace 8140; + } +) + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/reactions b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/reactions new file mode 100644 index 0000000000000000000000000000000000000000..e548bae90ffdb1e3d0822d8af80a19f9e2552636 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/reactions @@ -0,0 +1,20 @@ +species +( + O2 + H2O + CH4 + CO2 + N2 +); + +reactions +{ + methaneReaction + { + type irreversibleArrheniusReaction; + reaction "CH4 + 2O2 = CO2 + 2H2O"; + A 5.2e16; + beta 0; + Ta 14906; + } +} diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/thermo.compressibleGas b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/thermo.compressibleGas new file mode 100644 index 0000000000000000000000000000000000000000..ff00e560b42c710c641119bfac36920731b9024e --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/thermo.compressibleGas @@ -0,0 +1,129 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object thermo.compressibleGas; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +O2 +{ + specie + { + nMoles 1; + molWeight 31.9988; + } + thermodynamics + { + Tlow 200; + Thigh 5000; + Tcommon 1000; + highCpCoeffs ( 3.69758 0.00061352 -1.25884e-07 1.77528e-11 -1.13644e-15 -1233.93 3.18917 ); + lowCpCoeffs ( 3.21294 0.00112749 -5.75615e-07 1.31388e-09 -8.76855e-13 -1005.25 6.03474 ); + } + transport + { + As 1.67212e-06; + Ts 170.672; + } +} + +H2O +{ + specie + { + nMoles 1; + molWeight 18.0153; + } + thermodynamics + { + Tlow 200; + Thigh 5000; + Tcommon 1000; + highCpCoeffs ( 2.67215 0.00305629 -8.73026e-07 1.201e-10 -6.39162e-15 -29899.2 6.86282 ); + lowCpCoeffs ( 3.38684 0.00347498 -6.3547e-06 6.96858e-09 -2.50659e-12 -30208.1 2.59023 ); + } + transport + { + As 1.67212e-06; + Ts 170.672; + } +} + +CH4 +{ + specie + { + nMoles 1; + molWeight 16.0428; + } + thermodynamics + { + Tlow 200; + Thigh 6000; + Tcommon 1000; + highCpCoeffs ( 1.63543 0.0100844 -3.36924e-06 5.34973e-10 -3.15528e-14 -10005.6 9.9937 ); + lowCpCoeffs ( 5.14988 -0.013671 4.91801e-05 -4.84744e-08 1.66694e-11 -10246.6 -4.64132 ); + } + transport + { + As 1.67212e-06; + Ts 170.672; + } +} + +CO2 +{ + specie + { + nMoles 1; + molWeight 44.01; + } + thermodynamics + { + Tlow 200; + Thigh 5000; + Tcommon 1000; + highCpCoeffs ( 4.45362 0.00314017 -1.27841e-06 2.394e-10 -1.66903e-14 -48967 -0.955396 ); + lowCpCoeffs ( 2.27572 0.00992207 -1.04091e-05 6.86669e-09 -2.11728e-12 -48373.1 10.1885 ); + } + transport + { + As 1.67212e-06; + Ts 170.672; + } +} + +N2 +{ + specie + { + nMoles 1; + molWeight 28.0134; + } + thermodynamics + { + Tlow 200; + Thigh 5000; + Tcommon 1000; + highCpCoeffs ( 2.92664 0.00148798 -5.68476e-07 1.0097e-10 -6.75335e-15 -922.798 5.98053 ); + lowCpCoeffs ( 3.29868 0.00140824 -3.96322e-06 5.64152e-09 -2.44486e-12 -1020.9 3.95037 ); + } + transport + { + As 1.67212e-06; + Ts 170.672; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/thermophysicalProperties b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/thermophysicalProperties new file mode 100644 index 0000000000000000000000000000000000000000..ae0127213364320fba4e02c25be67c30bf20a30e --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/thermophysicalProperties @@ -0,0 +1,38 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object thermophysicalProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +thermoType +{ + type hePsiThermo; + mixture reactingMixture; + transport sutherland; + thermo janaf; + energy sensibleEnthalpy; + equationOfState perfectGas; + specie specie; +} + +inertSpecie N2; + +chemistryReader foamChemistryReader; + +foamChemistryFile "$FOAM_CASE/constant/reactions"; + +foamChemistryThermoFile "$FOAM_CASE/constant/thermo.compressibleGas"; + + +// ************************************************************************* // diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/RASProperties b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/turbulenceProperties similarity index 89% rename from tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/RASProperties rename to tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/turbulenceProperties index a4937b503a46850b2626f0d301e4a07b9f691507..c2c3b28a1b4e8f4a2cae55f58bd61f9b1a67b488 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/RASProperties +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/constant/turbulenceProperties @@ -11,15 +11,11 @@ FoamFile format ascii; class dictionary; location "constant"; - object RASProperties; + object turbulenceProperties; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -RASModel kEpsilon; - -turbulence on; - -printCoeffs on; +simulationType laminar; // ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/controlDict b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/controlDict new file mode 100644 index 0000000000000000000000000000000000000000..41925e2e0d57497df9c4d9e7c43d9163cc40b605 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/controlDict @@ -0,0 +1,48 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application LTSReactingFoam; + +startFrom startTime; + +startTime 0; + +stopAt endTime; + +endTime 1000; + +deltaT 1; + +writeControl runTime; + +writeInterval 20; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression off; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable true; + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/fvSchemes b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/fvSchemes new file mode 100644 index 0000000000000000000000000000000000000000..c6a1eaf3547778d8a5a1f221436846f03930b8ae --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/fvSchemes @@ -0,0 +1,64 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default localEuler rDeltaT; +} + +gradSchemes +{ + default Gauss linear; +} + +divSchemes +{ + default none; + + div(phi,U) Gauss limitedLinearV 1; + div(phi,Yi_h) Gauss limitedLinear01 1; + div(phi,h) Gauss limitedLinear 1; + div(phi,K) Gauss limitedLinear 1; + div(phid,p) Gauss limitedLinear 1; + div(phi,epsilon) Gauss limitedLinear 1; + div(phi,k) Gauss limitedLinear 1; + div((muEff*dev2(T(grad(U))))) Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear orthogonal; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default orthogonal; +} + +fluxRequired +{ + default no; + p; +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/fvSolution b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/fvSolution new file mode 100644 index 0000000000000000000000000000000000000000..dd9553bd5a2880f8b497c6f9a9d8d202652d3f76 --- /dev/null +++ b/tutorials/combustion/LTSReactingFoam/ras/counterFlowFlame2D/system/fvSolution @@ -0,0 +1,86 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "rho.*" + { + solver diagonal; + } + + p + { + solver PCG; + preconditioner DIC; + tolerance 1e-6; + relTol 0.1; + } + + pFinal + { + $p; + relTol 0; + } + + "(U|h|k|epsilon)" + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-6; + relTol 0.1; + } + + "(U|h|k|epsilon)Final" + { + $U; + relTol 0.1; + } + + Yi + { + $U; + relTol 0.1; + } +} + +PIMPLE +{ + momentumPredictor no; + nOuterCorrectors 1; + nCorrectors 1; + nNonOrthogonalCorrectors 0; + + maxDeltaT 1e-2; + maxCo 0.4; + alphaTemp 1; + rDeltaTSmoothingCoeff 1; + rDeltaTDampingCoeff 1; +} + +relaxationFactors +{ + fields + { + } + equations + { + ".*" 1; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/T b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/T index d5d567628e4dca3872118a365434ec53b2040838..fcf963a775b0fe6baa6f1e1be87fa9f52ba82eda 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/T +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/T @@ -36,7 +36,6 @@ boundaryField type inletOutlet; inletValue uniform 293; value uniform 293; - } frontAndBack { diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/U b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/U index 27773aea2ba6ac27ecb85fe3073258a65ab2d641..c235ba3d6599d2ee0addf202f46971a86b27b928 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/U +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/U @@ -33,7 +33,8 @@ boundaryField } outlet { - type zeroGradient; + type pressureInletOutletVelocity; + value $internalField; } frontAndBack { diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/p b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/p index 79f071ce3199a02c4b0b5f870d332ada0a20d176..deca9ba60da613c61097d7624095469169b50c65 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/p +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/0/p @@ -29,14 +29,16 @@ boundaryField { type zeroGradient; } - inlet2 - { - type zeroGradient; - } outlet { - type fixedValue; - value uniform 1e5; + type totalPressure; + p0 $internalField; + U U; + phi phi; + rho none; + psi none; + gamma 1; + value $internalField; } frontAndBack { diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/chemistryProperties b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/chemistryProperties index 3ce48f2eab7ae1a8ab5220a57e8e33a52c45731f..9c005101238147b75907e9bf44fd74699daefbbc 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/chemistryProperties +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/chemistryProperties @@ -38,7 +38,7 @@ EulerImplicitCoeffs odeCoeffs { - solver SIBS; + solver KRR4; eps 0.05; scale 1; } diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/combustionProperties b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/combustionProperties index 9c283d59334285e905cac329b9a6cdc222466fc1..d5c12209c1dac6c3e38c74191d14bc79977d6b3b 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/combustionProperties +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/combustionProperties @@ -15,14 +15,12 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -combustionModel PaSR<psiChemistryCombustion>; +combustionModel laminar<psiChemistryCombustion>; active true; -PaSRCoeffs +laminarCoeffs { - Cmix 0.1; - turbulentReaction off; } diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/turbulenceProperties b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/turbulenceProperties index 3721a46a2ead37eb2bf10434bcde59afa9fe9bf6..c2c3b28a1b4e8f4a2cae55f58bd61f9b1a67b488 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/turbulenceProperties +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/constant/turbulenceProperties @@ -15,7 +15,7 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -simulationType RASModel; +simulationType laminar; // ************************************************************************* // diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/controlDict b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/controlDict index 5c4ae1768dcebcac6620ec8e9e352b1fda90ba5d..a87c823f8f83a6291d5d464b166aedfc46ace9bf 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/controlDict +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/controlDict @@ -17,13 +17,13 @@ FoamFile application reactingFoam; -startFrom latestTime; +startFrom startTime; startTime 0; stopAt endTime; -endTime 0.3; +endTime 0.5; deltaT 1e-6; diff --git a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/fvSolution b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/fvSolution index fe09f9434a4e57c6158106d8ad1f3639fbb5b68c..7491893cc3ea0b75f0b6838e5d5ed6402b0f6cde 100644 --- a/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/fvSolution +++ b/tutorials/combustion/reactingFoam/ras/counterFlowFlame2D/system/fvSolution @@ -17,19 +17,9 @@ FoamFile solvers { - rho + "rho.*" { - solver PCG; - preconditioner DIC; - tolerance 1e-06; - relTol 0.1; - } - - rhoFinal - { - $rho; - tolerance 1e-06; - relTol 0; + solver diagonal; } p @@ -51,15 +41,13 @@ solvers { solver PBiCG; preconditioner DILU; - tolerance 1e-06; + tolerance 1e-6; relTol 0.1; } "(U|h|k|epsilon)Final" { - solver PBiCG; - preconditioner DILU; - tolerance 1e-06; + $U; relTol 0; } diff --git a/tutorials/lagrangian/LTSReactingParcelFoam/counterFlowFlame2D/system/controlDict b/tutorials/lagrangian/LTSReactingParcelFoam/counterFlowFlame2D/system/controlDict index eb9e326d6dadf7b3ce1da0067c83769f67f54686..bb20dffbf262c02f9c2374b28b124518d11febf4 100644 --- a/tutorials/lagrangian/LTSReactingParcelFoam/counterFlowFlame2D/system/controlDict +++ b/tutorials/lagrangian/LTSReactingParcelFoam/counterFlowFlame2D/system/controlDict @@ -17,13 +17,13 @@ FoamFile application LTSReactingParcelFoam; -startFrom latestTime; +startFrom startTime; startTime 0; stopAt endTime; -endTime 2000; +endTime 10000; deltaT 1;