diff --git a/applications/solvers/combustion/fireFoam/Make/files b/applications/solvers/combustion/fireFoam/Make/files deleted file mode 100644 index 2d50e5e765..0000000000 --- a/applications/solvers/combustion/fireFoam/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -fireFoam.C - -EXE = $(FOAM_APPBIN)/fireFoam diff --git a/applications/solvers/combustion/fireFoam/Make/options b/applications/solvers/combustion/fireFoam/Make/options deleted file mode 100644 index e4f4e40482..0000000000 --- a/applications/solvers/combustion/fireFoam/Make/options +++ /dev/null @@ -1,33 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/meshTools/lnInclude \ - -I$(LIB_SRC)/sampling/lnInclude \ - -I$(LIB_SRC)/MomentumTransportModels/momentumTransportModels/lnInclude \ - -I$(LIB_SRC)/MomentumTransportModels/compressible/lnInclude \ - -I$(LIB_SRC)/ThermophysicalTransportModels/lnInclude \ - -I$(LIB_SRC)/ThermophysicalTransportModels/fluidReactionThermo/lnInclude \ - -I$(LIB_SRC)/transportModels/lnInclude \ - -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \ - -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ - -I$(LIB_SRC)/thermophysicalModels/chemistryModel/lnInclude \ - -I$(LIB_SRC)/combustionModels/lnInclude \ - -I$(LIB_SRC)/thermophysicalModels/thermophysicalProperties/lnInclude \ - -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \ - -I$(LIB_SRC)/ODE/lnInclude - -EXE_LIBS = \ - -lfiniteVolume \ - -lfvModels \ - -lfvConstraints \ - -lmeshTools \ - -lsampling \ - -lmomentumTransportModels \ - -lcompressibleMomentumTransportModels \ - -lthermophysicalTransportModels \ - -lfluidReactionThermophysicalTransportModels \ - -lspecie \ - -lfluidThermophysicalModels \ - -lreactionThermophysicalModels \ - -lchemistryModel \ - -lcombustionModels \ - -lODE diff --git a/applications/solvers/combustion/fireFoam/UEqn.H b/applications/solvers/combustion/fireFoam/UEqn.H deleted file mode 100644 index 622ddbb130..0000000000 --- a/applications/solvers/combustion/fireFoam/UEqn.H +++ /dev/null @@ -1,33 +0,0 @@ - MRF.correctBoundaryVelocity(U); - - fvVectorMatrix UEqn - ( - fvm::ddt(rho, U) + fvm::div(phi, U) - + MRF.DDt(rho, U) - + turbulence->divDevTau(U) - == - fvModels.source(rho, U) - ); - - UEqn.relax(); - - fvConstraints.constrain(UEqn); - - if (pimple.momentumPredictor()) - { - solve - ( - UEqn - == - fvc::reconstruct - ( - ( - - ghf*fvc::snGrad(rho) - - fvc::snGrad(p_rgh) - )*mesh.magSf() - ) - ); - - fvConstraints.constrain(U); - K = 0.5*magSqr(U); - } diff --git a/applications/solvers/combustion/fireFoam/YEEqn.H b/applications/solvers/combustion/fireFoam/YEEqn.H deleted file mode 100644 index 0c0a772c80..0000000000 --- a/applications/solvers/combustion/fireFoam/YEEqn.H +++ /dev/null @@ -1,76 +0,0 @@ -tmp> mvConvection -( - fv::convectionScheme::New - ( - mesh, - fields, - phi, - mesh.divScheme("div(phi,Yi_h)") - ) -); -{ - combustion->correct(); - - forAll(Y, i) - { - if (composition.solve(i)) - { - volScalarField& Yi = Y[i]; - - fvScalarMatrix YiEqn - ( - fvm::ddt(rho, Yi) - + mvConvection->fvmDiv(phi, Yi) - + thermophysicalTransport->divj(Yi) - == - combustion->R(Yi) - + fvModels.source(rho, Yi) - ); - - YiEqn.relax(); - - fvConstraints.constrain(YiEqn); - - YiEqn.solve("Yi"); - - fvConstraints.constrain(Yi); - } - } - - composition.normalise(); - - volScalarField& he = thermo.he(); - - fvScalarMatrix EEqn - ( - fvm::ddt(rho, he) + mvConvection->fvmDiv(phi, he) - + fvc::ddt(rho, K) + fvc::div(phi, K) - + ( - he.name() == "e" - ? fvc::div - ( - fvc::absolute(phi/fvc::interpolate(rho), U), - p, - "div(phiv,p)" - ) - : -dpdt - ) - + thermophysicalTransport->divq(he) - == - combustion->Qdot() - + fvModels.source(rho, he) - ); - - EEqn.relax(); - - fvConstraints.constrain(EEqn); - - EEqn.solve(); - - fvConstraints.constrain(he); - - thermo.correct(); - - Info<< "min/max(T) = " - << min(T).value() << ", " << max(T).value() << endl; -} diff --git a/applications/solvers/combustion/fireFoam/createFieldRefs.H b/applications/solvers/combustion/fireFoam/createFieldRefs.H deleted file mode 100644 index 6e1184a1fa..0000000000 --- a/applications/solvers/combustion/fireFoam/createFieldRefs.H +++ /dev/null @@ -1,2 +0,0 @@ -const volScalarField& psi = thermo.psi(); -const volScalarField& T = thermo.T(); diff --git a/applications/solvers/combustion/fireFoam/createFields.H b/applications/solvers/combustion/fireFoam/createFields.H deleted file mode 100644 index e718cdb218..0000000000 --- a/applications/solvers/combustion/fireFoam/createFields.H +++ /dev/null @@ -1,117 +0,0 @@ -Info<< "Reading thermophysical properties\n" << endl; -autoPtr pThermo(fluidReactionThermo::New(mesh)); -fluidReactionThermo& thermo = pThermo(); -thermo.validate(args.executable(), "h", "e"); - -basicSpecieMixture& composition = thermo.composition(); -PtrList& Y = composition.Y(); - -Info<< "Creating field rho\n" << endl; -volScalarField rho -( - IOobject - ( - "rho", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - thermo.rho() -); - -volScalarField& p = thermo.p(); - -Info<< "\nReading field U\n" << endl; -volVectorField U -( - IOobject - ( - "U", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh -); - -#include "compressibleCreatePhi.H" - -#include "createMRF.H" - - -Info<< "Creating turbulence model\n" << endl; -autoPtr turbulence -( - compressible::momentumTransportModel::New - ( - rho, - U, - phi, - thermo - ) -); - -Info<< "Creating thermophysical transport model\n" << endl; -autoPtr thermophysicalTransport -( - fluidReactionThermophysicalTransportModel::New(turbulence(), thermo) -); - -Info<< "Creating combustion model\n" << endl; -autoPtr combustion -( - combustionModel::New(thermo, turbulence()) -); - - -#include "readGravitationalAcceleration.H" -#include "readhRef.H" -#include "gh.H" -#include "readpRef.H" - -volScalarField p_rgh -( - IOobject - ( - "p_rgh", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh -); - -mesh.setFluxRequired(p_rgh.name()); - -#include "phrghEqn.H" - - -multivariateSurfaceInterpolationScheme::fieldTable fields; - -forAll(Y, i) -{ - fields.add(Y[i]); -} -fields.add(thermo.he()); - -Info<< "Creating field dpdt\n" << endl; -volScalarField dpdt -( - IOobject - ( - "dpdt", - runTime.timeName(), - mesh - ), - mesh, - dimensionedScalar(p.dimensions()/dimTime, 0) -); - -Info<< "Creating field kinetic energy K\n" << endl; -volScalarField K("K", 0.5*magSqr(U)); - -#include "createFvModels.H" -#include "createFvConstraints.H" diff --git a/applications/solvers/combustion/fireFoam/fireFoam.C b/applications/solvers/combustion/fireFoam/fireFoam.C deleted file mode 100644 index 38fa4a8b7a..0000000000 --- a/applications/solvers/combustion/fireFoam/fireFoam.C +++ /dev/null @@ -1,139 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 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 . - -Application - fireFoam - -Description - Transient solver for fires and turbulent diffusion flames with optional - reacting particle clouds and surface film modelling via fvModels. - -\*---------------------------------------------------------------------------*/ - -#include "fvCFD.H" -#include "dynamicMomentumTransportModel.H" -#include "fluidReactionThermophysicalTransportModel.H" -#include "fluidReactionThermo.H" -#include "combustionModel.H" -#include "pimpleControl.H" -#include "fvModels.H" -#include "fvConstraints.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -int main(int argc, char *argv[]) -{ - #include "postProcess.H" - - #include "setRootCaseLists.H" - #include "createTime.H" - #include "createMesh.H" - #include "createControl.H" - #include "createFields.H" - #include "createFieldRefs.H" - #include "initContinuityErrs.H" - #include "createTimeControls.H" - #include "compressibleCourantNo.H" - #include "setInitialDeltaT.H" - - turbulence->validate(); - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - Info<< "\nStarting time loop\n" << endl; - - while (pimple.run(runTime)) - { - #include "readTimeControls.H" - #include "compressibleCourantNo.H" - #include "setMultiRegionDeltaT.H" - #include "setDeltaT.H" - - runTime++; - - Info<< "Time = " << runTime.timeName() << nl << endl; - - // --- PIMPLE loop - while (pimple.loop()) - { - if (!pimple.flow()) - { - if (pimple.models()) - { - fvModels.correct(); - } - - if (pimple.thermophysics()) - { - #include "YEEqn.H" - } - } - else - { - if (pimple.firstPimpleIter() && !pimple.simpleRho()) - { - #include "rhoEqn.H" - } - - if (pimple.models()) - { - fvModels.correct(); - } - - #include "UEqn.H" - - if (pimple.thermophysics()) - { - #include "YEEqn.H" - } - - // --- Pressure corrector loop - while (pimple.correct()) - { - #include "pEqn.H" - } - - if (pimple.turbCorr()) - { - turbulence->correct(); - thermophysicalTransport->correct(); - } - } - - rho = thermo.rho(); - } - - runTime.write(); - - Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" - << " ClockTime = " << runTime.elapsedClockTime() << " s" - << nl << endl; - } - - Info<< "End" << endl; - - return 0; -} - - -// ************************************************************************* // diff --git a/applications/solvers/combustion/fireFoam/pEqn.H b/applications/solvers/combustion/fireFoam/pEqn.H deleted file mode 100644 index 8b7a455d39..0000000000 --- a/applications/solvers/combustion/fireFoam/pEqn.H +++ /dev/null @@ -1,58 +0,0 @@ -rho = thermo.rho(); - -volScalarField rAU(1.0/UEqn.A()); -surfaceScalarField rhorAUf("rhorAUf", fvc::interpolate(rho*rAU)); -volVectorField HbyA(constrainHbyA(rAU*UEqn.H(), U, p)); - -surfaceScalarField phig("phig", -rhorAUf*ghf*fvc::snGrad(rho)*mesh.magSf()); - -surfaceScalarField phiHbyA -( - "phiHbyA", - ( - fvc::flux(rho*HbyA) - + MRF.zeroFilter(rhorAUf*fvc::ddtCorr(rho, U, phi)) - ) - + phig -); - -MRF.makeRelative(fvc::interpolate(rho), phiHbyA); - -// Update the pressure BCs to ensure flux consistency -constrainPressure(p_rgh, rho, U, phiHbyA, rhorAUf, MRF); - -while (pimple.correctNonOrthogonal()) -{ - fvScalarMatrix p_rghEqn - ( - fvm::ddt(psi, p_rgh) - + fvc::ddt(psi, rho)*gh - + fvc::ddt(psi)*pRef - + fvc::div(phiHbyA) - - fvm::laplacian(rhorAUf, p_rgh) - == - fvModels.source(psi, p_rgh, rho.name()) - ); - - p_rghEqn.solve(); - - if (pimple.finalNonOrthogonalIter()) - { - phi = phiHbyA + p_rghEqn.flux(); - U = HbyA + rAU*fvc::reconstruct((p_rghEqn.flux() + phig)/rhorAUf); - U.correctBoundaryConditions(); - fvConstraints.constrain(U); - } -} - -p = p_rgh + rho*gh + pRef; - -#include "rhoEqn.H" -#include "compressibleContinuityErrs.H" - -K = 0.5*magSqr(U); - -if (thermo.dpdt()) -{ - dpdt = fvc::ddt(p); -} diff --git a/applications/solvers/combustion/fireFoam/rhoEqn.H b/applications/solvers/combustion/fireFoam/rhoEqn.H deleted file mode 100644 index 34ba2d6bd1..0000000000 --- a/applications/solvers/combustion/fireFoam/rhoEqn.H +++ /dev/null @@ -1,46 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 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 . - -Global - rhoEqn - -Description - Solve the continuity for density. - -\*---------------------------------------------------------------------------*/ - -{ - fvScalarMatrix rhoEqn - ( - fvm::ddt(rho) - + fvc::div(phi) - == - fvModels.source(rho) - ); - - rhoEqn.solve(); - - fvConstraints.constrain(rho); -} - -// ************************************************************************* // diff --git a/applications/solvers/combustion/fireFoam/setMultiRegionDeltaT.H b/applications/solvers/combustion/fireFoam/setMultiRegionDeltaT.H deleted file mode 100644 index 8b41b506d9..0000000000 --- a/applications/solvers/combustion/fireFoam/setMultiRegionDeltaT.H +++ /dev/null @@ -1,56 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 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 . - -Global - setMultiRegionDeltaT - -Description - Reset the timestep to maintain a constant maximum Courant numbers. - Reduction of time-step is immediate, but increase is damped to avoid - unstable oscillations. - -\*---------------------------------------------------------------------------*/ - -if (adjustTimeStep) -{ - if (CoNum == -great) - { - CoNum = small; - } - - const scalar TFactorFluid = maxCo/(CoNum + small); - - const scalar dt0 = runTime.deltaTValue(); - - runTime.setDeltaT - ( - min - ( - dt0*min(TFactorFluid, 1.2), - maxDeltaT - ) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/combustion/reactingFoam/buoyantReactingFoam/createFields.H b/applications/solvers/combustion/reactingFoam/buoyantReactingFoam/createFields.H index 12a635d97d..870f98bfa9 100644 --- a/applications/solvers/combustion/reactingFoam/buoyantReactingFoam/createFields.H +++ b/applications/solvers/combustion/reactingFoam/buoyantReactingFoam/createFields.H @@ -86,9 +86,6 @@ volScalarField p_rgh mesh ); -// Force p_rgh to be consistent with p -p_rgh = p - rho*gh - pRef; - pressureReference pressureReference ( p, @@ -99,6 +96,8 @@ pressureReference pressureReference mesh.setFluxRequired(p_rgh.name()); +#include "hydrostaticInitialisation.H" + Info<< "Creating field dpdt\n" << endl; volScalarField dpdt ( diff --git a/bin/fireFoam b/bin/fireFoam new file mode 100755 index 0000000000..af2371f74e --- /dev/null +++ b/bin/fireFoam @@ -0,0 +1,47 @@ +#!/bin/sh +#------------------------------------------------------------------------------ +# ========= | +# \\ / F ield | OpenFOAM: The Open Source CFD Toolbox +# \\ / O peration | Website: https://openfoam.org +# \\ / A nd | Copyright (C) 2021 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 . +# +# Script +# fireFoam +# +# Description +# Script to inform the user that fireFoam has been replaced by the +# more general buoyantReactingFoam solver. +# +#------------------------------------------------------------------------------ + +cat << EOF + +The fireFoam solver has solver has been replaced by the more general +buoyantReactingFoam solver, which supports buoyant compressible +reacting flow coupled to multiple run-time-selectable lagrangian clouds and +surface film modelling. + +See the following cases for examples transferred from fireFoam: + + \$FOAM_TUTORIALS/combustion/buoyantReactingFoam/RAS + +EOF + +#------------------------------------------------------------------------------ diff --git a/etc/config.sh/bash_completion b/etc/config.sh/bash_completion index c174207c36..e084f3d7e6 100644 --- a/etc/config.sh/bash_completion +++ b/etc/config.sh/bash_completion @@ -1230,31 +1230,6 @@ _financialFoam_ () } complete -o filenames -o nospace -F _financialFoam_ financialFoam -_fireFoam_ () -{ - local cur="${COMP_WORDS[COMP_CWORD]}" - local prev="${COMP_WORDS[COMP_CWORD-1]}" - local line=${COMP_LINE} - local used=$(echo "$line" | grep -oE "\-[a-zA-Z]+ ") - - opts="-case -doc -fileHandler -help -hostRoots -libs -listFunctionObjects -listFvModels -listMomentumTransportModels -listScalarBCs -listSwitches -listVectorBCs -noFunctionObjects -parallel -postProcess -roots -srcDoc" - for o in $used ; do opts="${opts/$o/}" ; done - extra="" - - [ "$COMP_CWORD" = 1 ] || \ - case "$prev" in - -case) - opts="" ; extra="-d" ;; - -fileHandler) - opts="uncollated collated masterUncollated" ; extra="" ;; - -hostRoots|-libs|-roots) - opts="" ; extra="" ;; - *) ;; - esac - COMPREPLY=( $(compgen -W "${opts}" $extra -- ${cur}) ) -} -complete -o filenames -o nospace -F _fireFoam_ fireFoam - _flattenMesh_ () { local cur="${COMP_WORDS[COMP_CWORD]}" diff --git a/applications/solvers/combustion/fireFoam/phrghEqn.H b/src/finiteVolume/cfdTools/compressible/hydrostaticInitialisation.H similarity index 94% rename from applications/solvers/combustion/fireFoam/phrghEqn.H rename to src/finiteVolume/cfdTools/compressible/hydrostaticInitialisation.H index 3c5175f41f..6ea10a0568 100644 --- a/applications/solvers/combustion/fireFoam/phrghEqn.H +++ b/src/finiteVolume/cfdTools/compressible/hydrostaticInitialisation.H @@ -60,3 +60,8 @@ if (pimple.dict().lookupOrDefault("hydrostaticInitialization", false)) p_rgh = ph_rgh; } } +else +{ + // Force p_rgh to be consistent with p + p_rgh = p - rho*gh - pRef; +} diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/CH4 b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/CH4 similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/CH4 rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/CH4 diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/FSDomega b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/FSDomega similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/FSDomega rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/FSDomega diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/G b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/G similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/G rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/G diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/IDefault b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/IDefault similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/IDefault rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/IDefault diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/N2 b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/N2 similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/N2 rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/N2 diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/O2 b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/O2 similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/O2 rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/O2 diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/T b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/T similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/T rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/T diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/U b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/U similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/U rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/U diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/Ydefault b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/Ydefault similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/Ydefault rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/Ydefault diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/alphat b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/alphat similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/alphat rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/alphat diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/k b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/k similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/k rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/k diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/nut b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/nut similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/nut rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/nut diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/p b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/p similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/p rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/p diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/p_rgh b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/p_rgh similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/p_rgh rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/p_rgh diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/ph_rgh.orig b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/ph_rgh.orig similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/ph_rgh.orig rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/ph_rgh.orig diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/soot b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/soot similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/0/soot rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/0/soot diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/Allclean b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/Allclean similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/Allclean rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/Allclean diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/Allrun b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/Allrun similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/Allrun rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/Allrun diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/combustionProperties b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/combustionProperties similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/combustionProperties rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/combustionProperties diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/fvModels b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/fvModels similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/fvModels rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/fvModels diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/g b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/g similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/g rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/g diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/hRef b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/hRef similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/hRef rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/hRef diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/momentumTransport b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/momentumTransport similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/momentumTransport rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/momentumTransport diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/pRef b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/pRef similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/pRef rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/pRef diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/radiationProperties b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/radiationProperties similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/radiationProperties rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/radiationProperties diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/reaction b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/reaction similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/reaction rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/reaction diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/thermo.compressibleGas b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/thermo.compressibleGas similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/thermo.compressibleGas rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/thermo.compressibleGas diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/thermophysicalProperties b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/thermophysicalProperties similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/constant/thermophysicalProperties rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/constant/thermophysicalProperties diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/blockMeshDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/blockMeshDict similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/blockMeshDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/blockMeshDict diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/controlDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/controlDict similarity index 96% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/controlDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/controlDict index b75dd3a73c..1c6941fef1 100644 --- a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/controlDict +++ b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/controlDict @@ -14,7 +14,7 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -application fireFoam; +application buoyantReactingFoam; startFrom startTime; diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/createPatchDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/createPatchDict similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/createPatchDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/createPatchDict diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/fvSchemes b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/fvSchemes similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/fvSchemes rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/fvSchemes diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/fvSolution b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/fvSolution similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/fvSolution rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/fvSolution diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/topoSetDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/topoSetDict similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire2D/system/topoSetDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire2D/system/topoSetDict diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/CH4 b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/CH4 similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/CH4 rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/CH4 diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/G b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/G similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/G rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/G diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/IDefault b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/IDefault similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/IDefault rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/IDefault diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/N2 b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/N2 similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/N2 rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/N2 diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/O2 b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/O2 similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/O2 rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/O2 diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/T b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/T similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/T rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/T diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/U b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/U similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/U rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/U diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/Ydefault b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/Ydefault similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/Ydefault rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/Ydefault diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/alphat b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/alphat similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/alphat rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/alphat diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/k b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/k similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/k rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/k diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/nut b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/nut similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/nut rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/nut diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/p b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/p similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/p rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/p diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/p_rgh b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/p_rgh similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/p_rgh rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/p_rgh diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/ph_rgh.orig b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/ph_rgh.orig similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/0/ph_rgh.orig rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/0/ph_rgh.orig diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/Allclean b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/Allclean similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/Allclean rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/Allclean diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/Allrun b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/Allrun similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/Allrun rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/Allrun diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/combustionProperties b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/combustionProperties similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/combustionProperties rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/combustionProperties diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/fvModels b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/fvModels similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/fvModels rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/fvModels diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/g b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/g similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/g rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/g diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/hRef b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/hRef similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/hRef rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/hRef diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/momentumTransport b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/momentumTransport similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/momentumTransport rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/momentumTransport diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/pRef b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/pRef similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/pRef rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/pRef diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/radiationProperties b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/radiationProperties similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/radiationProperties rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/radiationProperties diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/reaction b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/reaction similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/reaction rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/reaction diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/thermo.compressibleGas b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/thermo.compressibleGas similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/thermo.compressibleGas rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/thermo.compressibleGas diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/thermophysicalProperties b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/thermophysicalProperties similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/constant/thermophysicalProperties rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/constant/thermophysicalProperties diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/blockMeshDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/blockMeshDict similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/blockMeshDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/blockMeshDict diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/controlDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/controlDict similarity index 96% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/controlDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/controlDict index 89e4e01d43..d50a3345f6 100644 --- a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/controlDict +++ b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/controlDict @@ -14,7 +14,7 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -application fireFoam; +application buoyantReactingFoam; startFrom latestTime; diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/createPatchDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/createPatchDict similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/createPatchDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/createPatchDict diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/decomposeParDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/decomposeParDict similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/decomposeParDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/decomposeParDict diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/fvSchemes b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/fvSchemes similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/fvSchemes rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/fvSchemes diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/fvSolution b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/fvSolution similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/fvSolution rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/fvSolution diff --git a/tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/topoSetDict b/tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/topoSetDict similarity index 100% rename from tutorials/combustion/fireFoam/LES/smallPoolFire3D/system/topoSetDict rename to tutorials/combustion/buoyantReactingFoam/RAS/smallPoolFire3D/system/topoSetDict