diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H b/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H index c3da8d972a299a103d802aacf2d74a964a9711d0..a382b769b53cbd05bce45cff5861435b19903f83 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H @@ -78,10 +78,6 @@ - fvc::div(phi2)*U2 ); - - Info<< "Calculating field g.h\n" << endl; - volScalarField gh("gh", g & mesh.C()); - volScalarField rAU1 ( IOobject diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H b/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H index b097abf7451d8c2dc6c500e6dd8d91ad4d281e2e..ea3f6bdb33827e223b782909a19e965c666f4d36 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H @@ -34,6 +34,7 @@ fvc::interpolate((1.0/rho1)*rAU1*phase1.turbulence().pPrime()) *fvc::snGrad(alpha1)*mesh.magSf() ); + phiP1.boundaryField() == 0; // Phase-2 pressure flux (e.g. due to particle-particle pressure) surfaceScalarField phiP2 @@ -42,6 +43,7 @@ fvc::interpolate((1.0/rho2)*rAU2*phase2.turbulence().pPrime()) *fvc::snGrad(alpha2)*mesh.magSf() ); + phiP2.boundaryField() == 0; surfaceScalarField phiHbyA1 ( @@ -126,9 +128,11 @@ ); pEqnComp1 = - fvc::ddt(rho1) - + fvc::div(phi1, rho1) - fvc::Sp(fvc::div(phi1), rho1) - + correction + ( + fvc::ddt(alpha1, rho1) + fvc::div(alphaPhi1, rho1) + - fvc::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), rho1) + )/rho1 + + (alpha1/rho1)*correction ( psi1*fvm::ddt(p) + fvm::div(phid1, p) - fvm::Sp(fvc::div(phid1), p) @@ -137,9 +141,11 @@ pEqnComp1().relax(); pEqnComp2 = - fvc::ddt(rho2) - + fvc::div(phi2, rho2) - fvc::Sp(fvc::div(phi2), rho2) - + correction + ( + fvc::ddt(alpha2, rho2) + fvc::div(alphaPhi2, rho2) + - fvc::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), rho2) + )/rho2 + + (alpha2/rho2)*correction ( psi2*fvm::ddt(p) + fvm::div(phid2, p) - fvm::Sp(fvc::div(phid2), p) @@ -150,12 +156,18 @@ else { pEqnComp1 = - fvc::ddt(rho1) + psi1*correction(fvm::ddt(p)) - + fvc::div(phi1, rho1) - fvc::Sp(fvc::div(phi1), rho1); + ( + fvc::ddt(alpha1, rho1) + fvc::div(alphaPhi1, rho1) + - fvc::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), rho1) + )/rho1 + + (alpha1*psi1/rho1)*correction(fvm::ddt(p)); pEqnComp2 = - fvc::ddt(rho2) + psi2*correction(fvm::ddt(p)) - + fvc::div(phi2, rho2) - fvc::Sp(fvc::div(phi2), rho2); + ( + fvc::ddt(alpha2, rho2) + fvc::div(alphaPhi2, rho2) + - fvc::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), rho2) + )/rho2 + + (alpha2*psi2/rho2)*correction(fvm::ddt(p)); } // Cache p prior to solve for density update @@ -171,11 +183,7 @@ solve ( - ( - (alpha1/rho1)*pEqnComp1() - + (alpha2/rho2)*pEqnComp2() - ) - + pEqnIncomp, + pEqnComp1() + pEqnComp2() + pEqnIncomp, mesh.solver(p.select(pimple.finalInnerIter())) ); @@ -201,8 +209,8 @@ fluid.dgdt() = ( - pos(alpha2)*(pEqnComp2 & p)/rho2 - - pos(alpha1)*(pEqnComp1 & p)/rho1 + pos(alpha2)*(pEqnComp2 & p)/max(alpha2, scalar(1e-3)) + - pos(alpha1)*(pEqnComp1 & p)/max(alpha1, scalar(1e-3)) ); p.relax(); diff --git a/applications/utilities/postProcessing/dataConversion/foamToEnsight/cellSets.H b/applications/utilities/postProcessing/dataConversion/foamToEnsight/cellSets.H index 1f66fa276e8e0e2e5340a35c64e56fe44b029c93..54887f662a2b560fdf8417bd8b8f1b33ac88cf55 100644 --- a/applications/utilities/postProcessing/dataConversion/foamToEnsight/cellSets.H +++ b/applications/utilities/postProcessing/dataConversion/foamToEnsight/cellSets.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -78,6 +78,26 @@ public: hexes(nCells), polys(nCells) {} + + + // Member Functions + + void setSize(const label nCells) + { + nTets = 0; + nPyrs = 0; + nPrisms = 0; + nHexesWedges = 0; + nPolys = 0; + + tets.setSize(nCells); + pyrs.setSize(nCells); + prisms.setSize(nCells); + wedges.setSize(nCells); + hexes.setSize(nCells); + polys.setSize(nCells); + } + }; diff --git a/applications/utilities/postProcessing/dataConversion/foamToEnsight/ensightMesh.C b/applications/utilities/postProcessing/dataConversion/foamToEnsight/ensightMesh.C index 0332572eeb0d16cdb907354ac36fd9a139063803..267b8dc84421a58f13afcfa678d86befe17ffcd9 100644 --- a/applications/utilities/postProcessing/dataConversion/foamToEnsight/ensightMesh.C +++ b/applications/utilities/postProcessing/dataConversion/foamToEnsight/ensightMesh.C @@ -47,7 +47,8 @@ License void Foam::ensightMesh::correct() { patchPartOffset_ = 2; - meshCellSets_ = mesh_.nCells(); + meshCellSets_.setSize(mesh_.nCells()); + boundaryFaceSets_.setSize(mesh_.boundary().size()); allPatchNames_.clear(); patchNames_.clear(); @@ -194,44 +195,41 @@ void Foam::ensightMesh::correct() { forAll(mesh_.boundary(), patchi) { - if (mesh_.boundary()[patchi].size()) - { - const polyPatch& p = mesh_.boundaryMesh()[patchi]; + const polyPatch& p = mesh_.boundaryMesh()[patchi]; - labelList& tris = boundaryFaceSets_[patchi].tris; - labelList& quads = boundaryFaceSets_[patchi].quads; - labelList& polys = boundaryFaceSets_[patchi].polys; + labelList& tris = boundaryFaceSets_[patchi].tris; + labelList& quads = boundaryFaceSets_[patchi].quads; + labelList& polys = boundaryFaceSets_[patchi].polys; - tris.setSize(p.size()); - quads.setSize(p.size()); - polys.setSize(p.size()); + tris.setSize(p.size()); + quads.setSize(p.size()); + polys.setSize(p.size()); - label nTris = 0; - label nQuads = 0; - label nPolys = 0; + label nTris = 0; + label nQuads = 0; + label nPolys = 0; - forAll(p, faceI) - { - const face& f = p[faceI]; + forAll(p, faceI) + { + const face& f = p[faceI]; - if (f.size() == 3) - { - tris[nTris++] = faceI; - } - else if (f.size() == 4) - { - quads[nQuads++] = faceI; - } - else - { - polys[nPolys++] = faceI; - } + if (f.size() == 3) + { + tris[nTris++] = faceI; + } + else if (f.size() == 4) + { + quads[nQuads++] = faceI; + } + else + { + polys[nPolys++] = faceI; } - - tris.setSize(nTris); - quads.setSize(nQuads); - polys.setSize(nPolys); } + + tris.setSize(nTris); + quads.setSize(nQuads); + polys.setSize(nPolys); } } @@ -242,12 +240,9 @@ void Foam::ensightMesh::correct() if (patchNames_.empty() || patchNames_.found(patchName)) { - if (mesh_.boundary()[patchi].size()) - { - nfp.nTris = boundaryFaceSets_[patchi].tris.size(); - nfp.nQuads = boundaryFaceSets_[patchi].quads.size(); - nfp.nPolys = boundaryFaceSets_[patchi].polys.size(); - } + nfp.nTris = boundaryFaceSets_[patchi].tris.size(); + nfp.nQuads = boundaryFaceSets_[patchi].quads.size(); + nfp.nPolys = boundaryFaceSets_[patchi].polys.size(); } reduce(nfp.nTris, sumOp<label>()); @@ -1148,6 +1143,7 @@ void Foam::ensightMesh::write if (nfp.nTris || nfp.nQuads || nfp.nPolys) { const polyPatch& p = mesh_.boundaryMesh()[patchi]; + const labelList& tris = boundaryFaceSets_[patchi].tris; const labelList& quads = boundaryFaceSets_[patchi].quads; const labelList& polys = boundaryFaceSets_[patchi].polys; diff --git a/src/meshTools/sets/topoSets/topoSet.C b/src/meshTools/sets/topoSets/topoSet.C index 691339102a442d918f67476e87ba96d6ca8972ce..79e3796baab586c438f6ca388fdefb3ff016ef06 100644 --- a/src/meshTools/sets/topoSets/topoSet.C +++ b/src/meshTools/sets/topoSets/topoSet.C @@ -344,7 +344,7 @@ Foam::topoSet::topoSet ( mesh.dbDir()/polyMesh::meshSubDir/"sets", word::null, - IOobject::MUST_READ, + r, //IOobject::MUST_READ, mesh.facesInstance() ), polyMesh::meshSubDir/"sets", diff --git a/src/regionModels/surfaceFilmModels/submodels/thermo/filmViscosityModel/thixotropicViscosity/thixotropicViscosity.C b/src/regionModels/surfaceFilmModels/submodels/thermo/filmViscosityModel/thixotropicViscosity/thixotropicViscosity.C index 9fd2eb7777741f08f321aede555ed40ddb7ef753..a23933030b1a519945789536653ebead7e836000 100644 --- a/src/regionModels/surfaceFilmModels/submodels/thermo/filmViscosityModel/thixotropicViscosity/thixotropicViscosity.C +++ b/src/regionModels/surfaceFilmModels/submodels/thermo/filmViscosityModel/thixotropicViscosity/thixotropicViscosity.C @@ -66,7 +66,11 @@ void thixotropicViscosity::updateMu() const volScalarField filmMass("filmMass", film.netMass() + mSMALL); // weighting field to blend new and existing mass contributions - const volScalarField w("w", max(0.0, min(1.0, deltaMass/filmMass))); + const volScalarField w + ( + "w", + max(scalar(0.0), min(scalar(1.0), deltaMass/filmMass)) + ); // evaluate thixotropic viscosity volScalarField muThx("muThx", muInf_/(sqr(1.0 - K_*lambda_) + ROOTVSMALL)); diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/nutWallFunctions/nutkAtmRoughWallFunction/nutkAtmRoughWallFunctionFvPatchScalarField.C b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/nutWallFunctions/nutkAtmRoughWallFunction/nutkAtmRoughWallFunctionFvPatchScalarField.C index 2406f30d0ad656f8534d8f1f807e2fa6ec1ba62b..9e724596bf18237891ae0c7a97fbf754087a0d62 100644 --- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/nutWallFunctions/nutkAtmRoughWallFunction/nutkAtmRoughWallFunctionFvPatchScalarField.C +++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/nutWallFunctions/nutkAtmRoughWallFunction/nutkAtmRoughWallFunctionFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -63,10 +63,10 @@ tmp<scalarField> nutkAtmRoughWallFunctionFvPatchScalarField::calcNut() const scalar uStar = Cmu25*sqrt(k[faceCellI]); scalar yPlus = uStar*y[faceI]/nuw[faceI]; - scalar Edash = (y[faceI] + z0_[faceI])/z0_[faceI]; + scalar Edash = (y[faceI] + z0_[faceI])/(z0_[faceI] + 1e-4); nutw[faceI] = - nuw[faceI]*(yPlus*kappa_/log(max(Edash, 1+1e-4)) - 1); + nuw[faceI]*(yPlus*kappa_/log(max(Edash, 1 + 1e-4)) - 1); if (debug) { diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/C3H8 b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/C3H8 new file mode 100755 index 0000000000000000000000000000000000000000..df1b2ab5da25d2c8bc795e41fb4958debf9871c7 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/C3H8 @@ -0,0 +1,65 @@ +/*--------------------------------*- 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 C3H8; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + outlet + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + ground + { + type zeroGradient; + } + + side + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + inlet + { + type totalFlowRateAdvectiveDiffusive; + phi phi; + rho rho; + value uniform 1; + } + + region0_to_pyrolysisRegion_coupledWall + { + type totalFlowRateAdvectiveDiffusive; + phi phi; + rho rho; + massFluxFraction 1.0; + value $internalField; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/IDefault b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/IDefault new file mode 100755 index 0000000000000000000000000000000000000000..629aa0b799c783524f36a1d5f5c3efe5efede723 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/IDefault @@ -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; + object IDefault; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 0 -3 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + + region0_to_pyrolysisRegion_coupledWall + { + type greyDiffusiveRadiation; + T T; + emissivityMode solidRadiation; + emissivity uniform 1.0; + value uniform 0; + } + + frontAndBack + { + type cyclic; + } + + ".*" + { + type greyDiffusiveRadiation; + T T; + emissivityMode lookup; + emissivity uniform 1.0; + value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/N2 b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/N2 new file mode 100755 index 0000000000000000000000000000000000000000..251bc6632f9a720a7771244fab9f0fcfd15098ea --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/N2 @@ -0,0 +1,58 @@ +/*--------------------------------*- 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 N2; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0.76699; + +boundaryField +{ + + outlet + { + type calculated; + value $internalField; + } + + ground + { + type calculated; + value $internalField; + } + + side + { + type calculated; + value $internalField; + } + + inlet + { + type calculated; + value $internalField; + } + + region0_to_pyrolysisRegion_coupledWall + { + type calculated; + value $internalField; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/O2 b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/O2 new file mode 100755 index 0000000000000000000000000000000000000000..91036e1a56a1e3de15df95dca82cfb89de9d852f --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/O2 @@ -0,0 +1,62 @@ +/*--------------------------------*- 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 0.23301; + +boundaryField +{ + + outlet + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + ground + { + type zeroGradient; + } + + side + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + inlet + { + type fixedValue; + value uniform 0; + } + + region0_to_pyrolysisRegion_coupledWall + { + type totalFlowRateAdvectiveDiffusive; + phi phi; + rho rho; + massFluxFraction 0.0; + value $internalField; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/T b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/T new file mode 100755 index 0000000000000000000000000000000000000000..c7614c8c273ae114c14d80d2205320431ead8bda --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/T @@ -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 volScalarField; + location "0"; + object T; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 1 0 0 0]; + +internalField uniform 298; + +boundaryField +{ + outlet + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + ground + { + type zeroGradient; + } + + side + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + inlet + { + type fixedValue; + value $internalField; + } + + region0_to_pyrolysisRegion_coupledWall + { + type filmPyrolysisRadiativeCoupledMixed; + Tnbr T; + kappa fluidThermo; + QrNbr none; + Qr Qr; + kappaName none; + filmDeltaDry 0.0; + filmDeltaWet 2e-4; + value $internalField; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/U b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/U new file mode 100755 index 0000000000000000000000000000000000000000..418120f1e9c49a0440c802c19d1de79096552286 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/U @@ -0,0 +1,63 @@ +/*--------------------------------*- 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 +{ + + outlet + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + ground + { + type fixedValue; + value $internalField; + } + + side + { + type pressureInletOutletVelocity; + phi phi; + value $internalField; + } + + inlet + { + type flowRateInletVelocity; + massFlowRate constant 0.01; + value uniform (0 0 0); + } + + region0_to_pyrolysisRegion_coupledWall + { + type mappedFlowRate; + phi phi; + nbrPhi phiGas; + rho rho; + value uniform (0 0 0); + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/Ydefault b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/Ydefault new file mode 100755 index 0000000000000000000000000000000000000000..cc3de91d28160e9a0e88611399e7bfd7169d1834 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/Ydefault @@ -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 volScalarField; + location "0"; + object Ydefault; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0.0; + +boundaryField +{ + + outlet + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + ground + { + type zeroGradient; + } + + side + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + + inlet + { + type fixedValue; + phi phi; + rho rho; + value uniform 0; + } + + region0_to_pyrolysisRegion_coupledWall + { + type totalFlowRateAdvectiveDiffusive; + phi phi; + rho rho; + massFluxFraction 0.0; + value $internalField; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/alphaSgs b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/alphaSgs new file mode 100644 index 0000000000000000000000000000000000000000..91c0c2894e3024443ce19558d2ef323443ca02a8 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/alphaSgs @@ -0,0 +1,58 @@ +/*--------------------------------*- 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 alphaSgs; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + outlet + { + type calculated; + value uniform 0; + } + + ground + { + type compressible::alphatWallFunction; + mut muSgs; + value uniform 0; + } + + side + { + type calculated; + value uniform 0; + } + + inlet + { + type calculated; + value uniform 0; + } + + region0_to_pyrolysisRegion_coupledWall + { + type compressible::alphatWallFunction; + mut muSgs; + value uniform 0; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/Tf b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/Tf new file mode 100755 index 0000000000000000000000000000000000000000..0ebaacfbc0ab1c93ba060480a5536c7e3e829515 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/Tf @@ -0,0 +1,62 @@ +/*--------------------------------*- 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/filmRegion"; + object Tf; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 1 0 0 0]; + +internalField uniform 298; + +boundaryField +{ + region0_to_filmRegion_coupledWall // Patch to pyrolysis + { + type mappedField; + sampleRegion pyrolysisRegion; + sampleMode nearestPatchFace; + samplePatch region0_to_pyrolysisRegion_coupledWall; + offset (0 0 0); + fieldName T; + setAverage no; + average 0; + value uniform 298; + } + + coupledWall_top // Patch to Region0 + { + type zeroGradient; + } + + "side.*" + { + type inletOutlet; + inletValue uniform 298; + value uniform 298; + } + + outlet + { + type zeroGradient; + } + + inlet + { + type fixedValue; + value uniform 298.0; + } +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/Uf b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/Uf new file mode 100755 index 0000000000000000000000000000000000000000..0ac01a3002d79b98cc4bbf7ef0b0d43de7d88b36 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/Uf @@ -0,0 +1,54 @@ +/*--------------------------------*- 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/filmRegion"; + object Uf; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + coupledWall_top // Patch to Region0 + { + type slip; + } + + region0_to_filmRegion_coupledWall // Patch to pyrolysis + { + type fixedValue; + value uniform (0 0 0); + } + + outlet + { + type zeroGradient; + } + + "side.*" + { + type fixedValue; + value uniform (0 0 0); + } + + inlet + { + type fixedValue; + rho rhof; + value uniform (0 0 -0.01); + } +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/deltaf b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/deltaf new file mode 100755 index 0000000000000000000000000000000000000000..69e916c492cb8c44a1a3fbb760e68baa0eca3954 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/filmRegion/deltaf @@ -0,0 +1,51 @@ +/*--------------------------------*- 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/filmRegion"; + object deltaf; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 0 0 0 0 0]; + +internalField uniform 1e-6; + +boundaryField +{ + coupledWall_top + { + type zeroGradient; + } + + region0_to_filmRegion_coupledWall + { + type zeroGradient; + } + + "side.*" + { + type zeroGradient; + } + + inlet + { + type fixedValue; + value uniform 6e-4; + } + + outlet + { + type zeroGradient; + } +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/k b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/k new file mode 100755 index 0000000000000000000000000000000000000000..2c8622d2286f433e3ee695a405829dff572f972b --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/k @@ -0,0 +1,55 @@ +/*--------------------------------*- 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 k; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + + +dimensions [0 2 -2 0 0 0 0]; + +internalField uniform 1e-5; + +boundaryField +{ + outlet + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + ground + { + type zeroGradient; + } + + side + { + type inletOutlet; + inletValue $internalField; + value $internalField; + } + inlet + { + type fixedValue; + value $internalField; + } + region0_to_pyrolysisRegion_coupledWall + { + type zeroGradient; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/muSgs b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/muSgs new file mode 100755 index 0000000000000000000000000000000000000000..9da5b0c67de46057a51f7b7f99381e0ebb6449d7 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/muSgs @@ -0,0 +1,60 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / 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; + location "0"; + class volScalarField; + object muSgs; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + + +dimensions [1 -1 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + outlet + { + type calculated; + value uniform 0; + } + + ground + { + type mutUSpaldingWallFunction; + value uniform 0; + } + + side + { + type calculated; + value uniform 0; + } + + inlet + { + type calculated; + value uniform 0; + } + + region0_to_pyrolysisRegion_coupledWall + { + type mutUSpaldingWallFunction; + value uniform 0; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p new file mode 100755 index 0000000000000000000000000000000000000000..9aee743d50a78a4ee7c791fe56fdd093da9e1056 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p @@ -0,0 +1,58 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / 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; + object p; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 101325; + +boundaryField +{ + + outlet + { + type calculated; + value $internalField; + } + + ground + { + type calculated; + value $internalField; + } + + side + { + type calculated; + value $internalField; + } + + inlet + { + type calculated; + value $internalField; + } + region0_to_pyrolysisRegion_coupledWall + { + type calculated; + value $internalField; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p_rgh b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p_rgh new file mode 100755 index 0000000000000000000000000000000000000000..e0461769d0df7f7d60f7dbff5bbbe256f9691ac8 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p_rgh @@ -0,0 +1,67 @@ +/*--------------------------------*- 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_rgh; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 101325; + +boundaryField +{ + wall + { + type fixedFluxPressure; + value $internalField; + } + + outlet + { + type fixedFluxPressure; + value $internalField; + } + + ground + { + type fixedFluxPressure; + + } + + side + { + type totalPressure; + U U; + phi phi; + rho rho; + psi none; + gamma 1.4; + p0 $internalField; + value $internalField; + } + + inlet + { + type fixedFluxPressure; + } + + region0_to_pyrolysisRegion_coupledWall + { + type fixedFluxPressure; + value $internalField; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Qr b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Qr new file mode 100755 index 0000000000000000000000000000000000000000..aaeee9d11c502629db6277670b0e16e1bd4394e6 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Qr @@ -0,0 +1,49 @@ +/*--------------------------------*- 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 Qr; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 0 -3 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + coupledWall_top + { + type zeroGradient; + } + + coupledWall_side + { + type empty; + } + + region0_to_pyrolysisRegion_coupledWall + { + type mappedField; + sampleRegion region0; + sampleMode nearestPatchFace; + samplePatch region0_to_pyrolysisRegion_coupledWall; + offset (0 0 0); + fieldName Qr; // this is the name of Qr field in region0 + setAverage no; + average 0; + value uniform 0; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/T b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/T new file mode 100755 index 0000000000000000000000000000000000000000..2664855cf3c7291bed9286f4d79ea0df8a995ce9 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/T @@ -0,0 +1,54 @@ +/*--------------------------------*- 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/pyrolysisRegion"; + object T; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 1 0 0 0]; + +internalField uniform 298; + +boundaryField +{ + coupledWall_top + { + type zeroGradient; + } + + coupledWall_side + { + type empty; + } + + region0_to_pyrolysisRegion_coupledWall + { + type filmPyrolysisRadiativeCoupledMixed; + Tnbr T; + kappa solidThermo; + kappaName none; + QrNbr Qr; + Qr none; + filmDeltaDry 0.0; + filmDeltaWet 2e-4; + value uniform 298; + } + oneDEmptyPatch + { + type empty; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Y0Default b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Y0Default new file mode 100755 index 0000000000000000000000000000000000000000..50c0c51a59c4996c70d14c2a4bc0bbcdaa12bc74 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/Y0Default @@ -0,0 +1,40 @@ +/*--------------------------------*- 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/pyrolysisRegion"; + object Ydefault; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + coupledWall_top + { + type zeroGradient; + } + region0_to_pyrolysisRegion_coupledWall + { + type zeroGradient; + } + oneDEmptyPatch + { + type empty; + } + +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/char b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/char new file mode 100755 index 0000000000000000000000000000000000000000..4b88585cc8654e446c146a9c8e55dbaa5272e4a6 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/char @@ -0,0 +1,41 @@ +/*--------------------------------*- 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/pyrolysisRegion"; + object Ychar; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + coupledWall_top + { + type zeroGradient; + } + + region0_to_pyrolysisRegion_coupledWall + { + type zeroGradient; + } + + oneDEmptyPatch + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/p b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/p new file mode 100755 index 0000000000000000000000000000000000000000..5e2985df7e46b4e2948c21a4a9a5b4abf3f96d59 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/p @@ -0,0 +1,32 @@ +/*--------------------------------*- 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 +{ + + ".*" + { + type zeroGradient; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/wood b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/wood new file mode 100755 index 0000000000000000000000000000000000000000..3e15d9f4262d9ae59d4ba1b1058317412e59b6d1 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/pyrolysisRegion/wood @@ -0,0 +1,39 @@ +/*--------------------------------*- 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/pyrolysisRegion"; + object wood; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 1; + +boundaryField +{ + coupledWall_top + { + type zeroGradient; + } + region0_to_pyrolysisRegion_coupledWall + { + type zeroGradient; + } + oneDEmptyPatch + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/Allclean b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/Allclean new file mode 100755 index 0000000000000000000000000000000000000000..1b6c341340783be86701f5c0b85f0e99a1f81e27 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/Allclean @@ -0,0 +1,14 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # run from this directory + +# Source tutorial clean functions +. $WM_PROJECT_DIR/bin/tools/CleanFunctions + +cleanCase + +rm -rf constant/filmRegion/polyMesh +rm -rf constant/pyrolysisRegion/polyMesh + +rm -rf system/pyrolysisRegion/filmRegion + +# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/Allrun b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/Allrun new file mode 100755 index 0000000000000000000000000000000000000000..6945c4e06e0ca440e259643b907e48d1ae2d03d6 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/Allrun @@ -0,0 +1,41 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # run from this directory + +# Source tutorial run functions +. $WM_PROJECT_DIR/bin/tools/RunFunctions + +# create the underlying block mesh +runApplication blockMesh + +# create faceSet for burner inlet and faceZone for coupled wall +runApplication topoSet + +# create burner inlet +runApplication createPatch -overwrite + +# extrude Film +runApplication extrudeToRegionMesh -dict system/extrudeToRegionMeshDictFilm -overwrite + +rm log.extrudeToRegionMesh + +# extrude pyrolysis +runApplication extrudeToRegionMesh -dict system/extrudeToRegionMeshDictPyr -overwrite + +# change samplePatch in the boundary to coupled patch betwee region0 and +# pyrolysis +runApplication changeDictionary -region filmRegion -constant + +# create faceSets for inlet, outlet, sides for the Film +rm log.topoSet +runApplication topoSet -region filmRegion + +rm log.createPatch +# create actual patches +runApplication createPatch -region filmRegion -overwrite + +# Run +runApplication `getApplication` + +paraFoam -touchAll + +# ----------------------------------------------------------------- end-of-file \ No newline at end of file diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/LESProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/LESProperties new file mode 100644 index 0000000000000000000000000000000000000000..5ecdc02d18a2f1602cec522f63bce5623f3b34aa --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/LESProperties @@ -0,0 +1,93 @@ +/*--------------------------------*- 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 LESProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +LESModel oneEqEddy; + +delta cubeRootVol; + +turbulence on; + +printCoeffs on; + +oneEqEddyCoeffs +{ + Prt 1; +} + +cubeRootVolCoeffs +{ + deltaCoeff 1; +} + +PrandtlCoeffs +{ + delta cubeRootVol; + cubeRootVolCoeffs + { + deltaCoeff 1; + } + + smoothCoeffs + { + delta cubeRootVol; + cubeRootVolCoeffs + { + deltaCoeff 1; + } + + maxDeltaRatio 1.1; + } + + Cdelta 0.158; +} + +vanDriestCoeffs +{ + delta cubeRootVol; + cubeRootVolCoeffs + { + deltaCoeff 1; + } + + smoothCoeffs + { + delta cubeRootVol; + cubeRootVolCoeffs + { + deltaCoeff 1; + } + + maxDeltaRatio 1.1; + } + + Aplus 26; + Cdelta 0.158; +} + +smoothCoeffs +{ + delta cubeRootVol; + cubeRootVolCoeffs + { + deltaCoeff 1; + } + + maxDeltaRatio 1.1; +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/additionalControls b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/additionalControls new file mode 100755 index 0000000000000000000000000000000000000000..ccf72d6127fe929daa8364cccbd9268a0a5d4705 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/additionalControls @@ -0,0 +1,20 @@ +/*--------------------------------*- 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 additionalControls; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvePrimaryRegion true; + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/combustionProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/combustionProperties new file mode 100755 index 0000000000000000000000000000000000000000..a57292861b47fef3925f42532899f8b20866a5a2 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/combustionProperties @@ -0,0 +1,26 @@ +/*--------------------------------*- 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 infinitelyFastChemistry<psiThermoCombustion,gasHThermoPhysics>; + +active true; + +infinitelyFastChemistryCoeffs +{ + semiImplicit no; + C 10; +} diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/g b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/g new file mode 100755 index 0000000000000000000000000000000000000000..b10785499bf70ecbdd938de4c1a41c842400e787 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/g @@ -0,0 +1,21 @@ +/*--------------------------------*- 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 -9.8); + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/polyMesh/blockMeshDict b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/polyMesh/blockMeshDict new file mode 100644 index 0000000000000000000000000000000000000000..b4802459ae92a29a5661f0862baa3b777b9d96c2 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/polyMesh/blockMeshDict @@ -0,0 +1,87 @@ +/*-----------------------------*-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) + (1 0 0) + (1 1 0) + (0 1 0) + (0 0 2) + (1 0 2) + (1 1 2) + (0 1 2) +); + +blocks +( + hex (0 1 2 3 4 5 6 7) (10 20 20) simpleGrading (1 1 1) +); + +edges +( +); + +boundary +( + side + { + type patch; + faces + ( + (1 2 6 5) + (0 1 5 4) + (7 6 2 3) + ); + } + + outlet + { + type patch; + faces + ( + (4 5 6 7) + ); + } + + ground + { + type wall; + faces + ( + (0 3 2 1) + ); + } + + coupledWallTmp + { + type wall; + faces + ( + (0 4 7 3) + ); + } + +); + +mergePatchPairs +( +); + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/chemistryProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/chemistryProperties new file mode 100644 index 0000000000000000000000000000000000000000..1366ff04bdf5e7bb89a39616cb80ef065906cdd6 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/chemistryProperties @@ -0,0 +1,34 @@ +/*--------------------------------*- 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 pyrolysis; +} + +chemistry on; + +initialChemicalTimeStep 1e-07; + +odeCoeffs +{ + solver SIBS; + eps 0.05; +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/radiationProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/radiationProperties new file mode 100644 index 0000000000000000000000000000000000000000..e59089a58539bdfa7adde05b4968c36f67ef3f2f --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/radiationProperties @@ -0,0 +1,42 @@ +/*--------------------------------*- 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 radiationProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +radiationModel opaqueSolid; + +absorptionEmissionModel greyMeanSolidAbsorptionEmission; + + +greyMeanSolidAbsorptionEmissionCoeffs +{ + wood + { + absorptivity 0.17; + emissivity 0.17; + } + + char + { + absorptivity 0.85; + emissivity 0.85; + } +} + +scatterModel none; + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/reactions b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/reactions new file mode 100644 index 0000000000000000000000000000000000000000..7fc5f0719be60dc5ff7dc6805178ee1d9f82004c --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/reactions @@ -0,0 +1,22 @@ +species +( + wood + char +); + +gaseousSpecies +( + gas +); + +reactions +{ + charReaction + { + type irreversibleArrheniusSolidReaction; + reaction "wood^4.86 = char + gas"; + A 7.83e10; + Ta 15274.57; + Tcrit 400; + } +} diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/thermo.solid b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/thermo.solid new file mode 100644 index 0000000000000000000000000000000000000000..a4b2c48134af29807b445bf6c48b5d530ec22f0c --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/thermo.solid @@ -0,0 +1,62 @@ +/*--------------------------------*- 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 binary; + class dictionary; + location "constant"; + object thermo.solid; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +wood +{ + specie + { + nMoles 1; + molWeight 100; + } + transport + { + kappa 0.135; + } + thermodynamics + { + Cp 696; + Hf -1.41e6; + } + equationOfState + { + rho 114.7; + } +}; + +char +{ + specie + { + nMoles 1; + molWeight 50; + } + transport + { + kappa 0.4; + } + thermodynamics + { + Cp 611; + Hf 0; + } + equationOfState + { + rho 11.5; + } +}; + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/thermophysicalProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/thermophysicalProperties new file mode 100644 index 0000000000000000000000000000000000000000..4765d84e02f76676776fc741b5e73270ff0e41e6 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisRegion/thermophysicalProperties @@ -0,0 +1,68 @@ +/*--------------------------------*- 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 thermophysicalProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +thermoType +{ + type heSolidThermo; + mixture reactingMixture; + transport constIso; + thermo hConst; + equationOfState rhoConst; + specie specie; + energy sensibleEnthalpy; +} + + +chemistryReader foamChemistryReader; + +foamChemistryFile "$FOAM_CASE/constant/pyrolysisRegion/reactions"; + +foamChemistryThermoFile "$FOAM_CASE/constant/pyrolysisRegion/thermo.solid"; + +gasThermoType +{ + transport sutherland; + thermo janaf; + equationOfState perfectGas; + specie specie; + energy sensibleEnthalpy; +} + + +gas +{ + specie + { + nMoles 1; + molWeight 18.0153; + } + thermodynamics + { + Tlow 200; + Thigh 5000; + Tcommon 1000; + highCpCoeffs ( 2.67215 0.00305629 -8.73026e-07 1.20100e-10 -6.39162e-15 -29899.2 6.86282 ); + lowCpCoeffs ( 3.38684 0.00347498 -6.35470e-06 6.96858e-09 -2.50659e-12 -30208.1 2.59023 ); + } + transport + { + As 1.67212e-06; + Ts 170.672; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisZones b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisZones new file mode 100755 index 0000000000000000000000000000000000000000..f4ba9724e7253c069ea386027cd58448bc3ddec9 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/pyrolysisZones @@ -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 binary; + class dictionary; + location "constant"; + object pyrolysisProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +1 +( + pyrolysis + { + active true; + + pyrolysisModel reactingOneDim; + + regionName pyrolysisRegion; + + reactingOneDimCoeffs + { + filmCoupled true; + + gasHSource true; + QrHSource false; + + radFluxName Qr; + + moveMesh false; // true; + minimumDelta 1e-6; + + useChemistrySolvers true; + } + } + +) + +// ************************************************************************* // \ No newline at end of file diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/radiationProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/radiationProperties new file mode 100755 index 0000000000000000000000000000000000000000..392c1acad2ccf0ebd05304d8cdbbd522f2390ba3 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/radiationProperties @@ -0,0 +1,60 @@ +/*--------------------------------*- 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 radiationProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +radiation on; + +radiationModel fvDOM; + + +fvDOMCoeffs +{ + nPhi 2; // azimuthal angles in PI/2 on X-Y.(from Y to X) + nTheta 2; // polar angles in PI (from Z to X-Y plane) + convergence 1e-2; // convergence criteria for radiation iteration + maxIter 3; // maximum number of iterations + cacheDiv true; // cache the div of the RTE equation. +} + +// Number of flow iterations per radiation iteration +solverFreq 10; + +absorptionEmissionModel constantAbsorptionEmission; + +constantAbsorptionEmissionCoeffs +{ + absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.1; + emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; + E E [ 1 -1 -3 0 0 0 0 ] 0; +} + +greyMeanAbsorptionEmissionSootCoeffs +{ + + lookUpTableFileName none; + EhrrCoeff 0.4; +} + +scatterModel constantScatter; + +constantScatterCoeffs +{ + sigma sigma [ 0 -1 0 0 0 0 0 ] 0; + C C [ 0 0 0 0 0 0 0 ] 0; +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactingCloud1Positions b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactingCloud1Positions new file mode 100755 index 0000000000000000000000000000000000000000..f369d4d97d64099d56e97444820c59953c98c8b1 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactingCloud1Positions @@ -0,0 +1,20 @@ +/*--------------------------------*- 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 vectorField; + location "constant"; + object reactingCloud1Positions; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +( + +) +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactingCloud1Properties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactingCloud1Properties new file mode 100755 index 0000000000000000000000000000000000000000..330a418c283d54b788fd41f4f79c17e7ba341fc5 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactingCloud1Properties @@ -0,0 +1,254 @@ +/*--------------------------------*- 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 reactingCloud1Properties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solution +{ + active false; + coupled yes; + transient yes; + cellValueSourceCorrection yes; + + sourceTerms + { + schemes + { + rho explicit 1; + U explicit 1; + Yi explicit 1; + hs explicit 1; + } + } + + interpolationSchemes + { + rho cell; + U cellPoint; + mu cell; + T cell; + Cp cell; + p cell; + } + + integrationSchemes + { + U Euler; + T analytical; + } +} + +constantProperties +{ + parcelTypeId 1; + + rhoMin 1e-15; + TMin 200; + pMin 1000; + minParticleMass 1e-15; + + rho0 1000; + T0 300; + Cp0 4187; + + youngsModulus 1e9; + poissonsRatio 0.35; + + epsilon0 1; + f0 0.5; + Pr 0.7; + Tvap 273; + Tbp 373; + + constantVolume false; +} + +subModels +{ + particleForces + { + sphereDrag; + gravity; + } + + injectionModel none;//coneInjection; + + dispersionModel none; + + patchInteractionModel standardWallInteraction; + + heatTransferModel none; + + compositionModel singlePhaseMixture; + + phaseChangeModel none; + + surfaceFilmModel thermoSurfaceFilm; + + radiation off; + + coneNozzleInjectionCoeffs + { + massTotal massTotal [ 1 0 0 0 0 ] 0.0005; + parcelBasisType mass; + SOI 0.001; + duration 10; //0.005; + position ( 0. 0.0 0.0 ); + direction ( 0 -1 0 ); + parcelsPerSecond 10000; + //flowRateProfile constant 0.01; + flowRateProfile constant 0.01; + Umag constant 50; + thetaInner constant 0; + thetaOuter constant 30; + + parcelPDF + { + pdfType RosinRammler; + RosinRammlerPDF + { + minValue 5e-05; + maxValue 0.0001; + // d ( 7.5e-05 ); + d 7.5e-05; + // n ( 0.5 ); + n 0.5; + } + } + } + + coneInjectionCoeffs + { + SOI 1055.00;//800.000; + duration 1000.00;//1800.000; + // positionsFile "reactingCloud1Positions"; + // axesFile "reactingCloud1Axes"; + positionAxis + ( + ( ( -2.13360 4.47040 -1.52400) ( 0 -1 0 ) ) + ( ( -1.52400 4.47040 -1.52400) ( 0 -1 0 ) ) + ( ( -0.91440 4.47040 -1.52400) ( 0 -1 0 ) ) + ( ( -0.30480 4.47040 -1.52400) ( 0 -1 0 ) ) + ( ( 0.30480 4.47040 -1.52400) ( 0 -1 0 ) ) + ( ( 0.91440 4.47040 -1.52400) ( 0 -1 0 ) ) + ( ( 1.52400 4.47040 -1.52400) ( 0 -1 0 ) ) + ( ( 2.13360 4.47040 -1.52400) ( 0 -1 0 ) ) + + ( ( -2.13360 4.47040 -0.91440) ( 0 -1 0 ) ) + ( ( -1.52400 4.47040 -0.91440) ( 0 -1 0 ) ) + ( ( -0.91440 4.47040 -0.91440) ( 0 -1 0 ) ) + ( ( -0.30480 4.47040 -0.91440) ( 0 -1 0 ) ) + ( ( 0.30480 4.47040 -0.91440) ( 0 -1 0 ) ) + ( ( 0.91440 4.47040 -0.91440) ( 0 -1 0 ) ) + ( ( 1.52400 4.47040 -0.91440) ( 0 -1 0 ) ) + ( ( 2.13360 4.47040 -0.91440) ( 0 -1 0 ) ) + + ( ( -2.13360 4.47040 -0.30480) ( 0 -1 0 ) ) + ( ( -1.52400 4.47040 -0.30480) ( 0 -1 0 ) ) + ( ( -0.91440 4.47040 -0.30480) ( 0 -1 0 ) ) + ( ( -0.30480 4.47040 -0.30480) ( 0 -1 0 ) ) + ( ( 0.30480 4.47040 -0.30480) ( 0 -1 0 ) ) + ( ( 0.91440 4.47040 -0.30480) ( 0 -1 0 ) ) + ( ( 1.52400 4.47040 -0.30480) ( 0 -1 0 ) ) + ( ( 2.13360 4.47040 -0.30480) ( 0 -1 0 ) ) + + ( ( -2.13360 4.47040 0.30480) ( 0 -1 0 ) ) + ( ( -1.52400 4.47040 0.30480) ( 0 -1 0 ) ) + ( ( -0.91440 4.47040 0.30480) ( 0 -1 0 ) ) + ( ( -0.30480 4.47040 0.30480) ( 0 -1 0 ) ) + ( ( 0.30480 4.47040 0.30480) ( 0 -1 0 ) ) + ( ( 0.91440 4.47040 0.30480) ( 0 -1 0 ) ) + ( ( 1.52400 4.47040 0.30480) ( 0 -1 0 ) ) + ( ( 2.13360 4.47040 0.30480) ( 0 -1 0 ) ) + + ( ( -2.13360 4.47040 0.91440) ( 0 -1 0 ) ) + ( ( -1.52400 4.47040 0.91440) ( 0 -1 0 ) ) + ( ( -0.91440 4.47040 0.91440) ( 0 -1 0 ) ) + ( ( -0.30480 4.47040 0.91440) ( 0 -1 0 ) ) + ( ( 0.30480 4.47040 0.91440) ( 0 -1 0 ) ) + ( ( 0.91440 4.47040 0.91440) ( 0 -1 0 ) ) + ( ( 1.52400 4.47040 0.91440) ( 0 -1 0 ) ) + ( ( 2.13360 4.47040 0.91440) ( 0 -1 0 ) ) + + ( ( -2.13360 4.47040 1.52400) ( 0 -1 0 ) ) + ( ( -1.52400 4.47040 1.52400) ( 0 -1 0 ) ) + ( ( -0.91440 4.47040 1.52400) ( 0 -1 0 ) ) + ( ( -0.30480 4.47040 1.52400) ( 0 -1 0 ) ) + ( ( 0.30480 4.47040 1.52400) ( 0 -1 0 ) ) + ( ( 0.91440 4.47040 1.52400) ( 0 -1 0 ) ) + ( ( 1.52400 4.47040 1.52400) ( 0 -1 0 ) ) + ( ( 2.13360 4.47040 1.52400) ( 0 -1 0 ) ) + ); + + //massTotal is the total for all injectors + massTotal 1211.35; //kg over 1000 seconds (0.1 gpm/ft2) + //massTotal 3634.05; //kg over 1000 seconds (0.3 gpm/ft2) + + parcelsPerInjector 30000; + parcelsPerSecond 500; + parcelBasisType mass; + flowRateProfile constant 0.1; + Umag constant 2.0; + thetaInner constant 5; + thetaOuter constant 120; + + sizeDistribution + { + type uniform; + uniformDistribution + { + minValue 0.001; + maxValue 0.002; + d ( 7.5e-05 ); + n ( 0.5 ); + } + } + } + + + standardWallInteractionCoeffs + { + type escape;//stick;//rebound; + } + + RanzMarshallCoeffs + { + // thermal shielding + BirdCorrection true; + } + + singlePhaseMixtureCoeffs + { + phases + ( + liquid + { + H2O 1; + } + ); + } + + thermoSurfaceFilmCoeffs + { + interactionType splashBai; + deltaWet 0.0002; + Adry 2630; + Awet 1320; + Cf 0.6; + } + +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactions b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactions new file mode 100755 index 0000000000000000000000000000000000000000..d0b053b1794aceebb2c7ff92188dbc1e820ce559 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/reactions @@ -0,0 +1,17 @@ +species +( + O2 + H2O + C3H8 + CO2 + N2 +); + +reactions +{ + propaneReaction + { + type irreversibleinfiniteReaction; + reaction "C3H8 + 5O2 + 18.8N2 = 3CO2 + 4H2O + 18.8N2"; + } +} diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/surfaceFilmProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/surfaceFilmProperties new file mode 100755 index 0000000000000000000000000000000000000000..05847fabf5c5991d3269d8d04f3af5c117367a2d --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/surfaceFilmProperties @@ -0,0 +1,138 @@ +/*--------------------------------*- 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 SurfaceFilmProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +active true; + +surfaceFilmModel thermoSingleLayer; + +regionName filmRegion; + +thermoSingleLayerCoeffs +{ + thermoModel singleComponent; + + hydrophilic no; + deltaWet 1e-4; + + liquid H2O; + + turbulence laminar; + laminarCoeffs + { + Cf 0.005; + } + + radiationModel none; + standardRadiationCoeffs + { + //deltaMi 1e-6; + beta 0.75; + kappaBar 0.25; + } + + upperSurfaceModels + { + + heatTransferModel constant; + constantCoeffs + { + c0 10; + } + } + + lowerSurfaceModels + { + heatTransferModel constant; + constantCoeffs + { + c0 100; + } + } + + forces + ( + surfaceShear + thermocapillary + //contactAngle + ); + + surfaceShearCoeffs + { + Cf 0.005; + } + + contactAngleCoeffs + { + Ccf 0.085; + contactAngleDistribution + { + type normal; + normalDistribution + { + minValue 50; + maxValue 100; + expectation 75; + variance 100; + } + } + zeroForcePatches + (); + } + + injectionModels + ( + //curvatureSeparation + //drippingInjection + ); + + curvatureSeparationCoeffs + { + definedPatchRadii + ( + ("(cube[0-9][0-9]_side[0-9]_to_cube[0-9][0-9]_side[0-9])" 0) + ); + } + + drippingInjectionCoeffs + { + cloudName reactingCloud1; + deltaStable 0; + + particlesPerParcel 100.0; + + parcelDistribution + { + type RosinRammler; + RosinRammlerDistribution + { + minValue 5e-04; + maxValue 0.0012; + d 7.5e-05; + n 0.5; + } + } + } + + phaseChangeModel standardPhaseChange; + + standardPhaseChangeCoeffs + { + Tb 373; + deltaMin 1e-8; + L 1.0; + } +} \ No newline at end of file diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/thermo.compressibleGas b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/thermo.compressibleGas new file mode 100755 index 0000000000000000000000000000000000000000..d2d8f2cd2a31ace40060deb04df1a606715a2b4b --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/thermo.compressibleGas @@ -0,0 +1,126 @@ +/*--------------------------------*- 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; + } +} + +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; + } +} + +C3H8 +{ + specie + { + nMoles 1; + molWeight 44.0962; + } + thermodynamics + { + Tlow 200; + Thigh 5000; + Tcommon 1000; + highCpCoeffs ( 7.5341368 0.018872239 -6.2718491e-06 9.1475649e-10 -4.7838069e-14 -16467.516 -17.892349 ); + lowCpCoeffs ( 0.93355381 0.026424579 6.1059727e-06 -2.1977499e-08 9.5149253e-12 -13958.52 19.201691 ); + } + transport + { + As 1.67212e-06; + Ts 170.672; + } +} diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/thermophysicalProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/thermophysicalProperties new file mode 100755 index 0000000000000000000000000000000000000000..8ce5d08b45c1d30c52a2c071d03010d5d56a38d0 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/thermophysicalProperties @@ -0,0 +1,51 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / 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 singleStepReactingMixture; + transport sutherland; + thermo janaf; + energy sensibleEnthalpy; + equationOfState perfectGas; + specie specie; +} + +inertSpecie N2; + +fuel C3H8; + +chemistryReader foamChemistryReader; + +foamChemistryFile "$FOAM_CASE/constant/reactions"; + +foamChemistryThermoFile "$FOAM_CASE/constant/thermo.compressibleGas"; + + +liquids +{ + H2O + { + defaultCoeffs yes; + } +} + +solids +{ +} diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/turbulenceProperties b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/turbulenceProperties new file mode 100755 index 0000000000000000000000000000000000000000..098d0823ab8eea1574eccb5c77ffe4f4559166db --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/constant/turbulenceProperties @@ -0,0 +1,23 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / 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 turbulenceProperties; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +simulationType LESModel; + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/controlDict b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/controlDict new file mode 100644 index 0000000000000000000000000000000000000000..471023d263d9364fea45cd8210e8b71cb527b048 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/controlDict @@ -0,0 +1,59 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / 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 controlDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application fireFoam; + +startFrom startTime; + +startTime 0; + +stopAt endTime; + +endTime 10; + +deltaT 0.005; + +writeControl adjustableRunTime; + +writeInterval 1; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +graphFormat raw; + +runTimeModifiable yes; + +adjustTimeStep yes; + +maxCo 1.0; + +maxDi 0.25; + +maxDeltaT 0.01; + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/createPatchDict b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/createPatchDict new file mode 100644 index 0000000000000000000000000000000000000000..8fb65d5c53857c310111fa63b16d790822eb7693 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/createPatchDict @@ -0,0 +1,41 @@ +/*--------------------------------*- 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 createPatchDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +pointSync false; + +// Patches to create. +patches +( + { + // Name of new patch + name inlet; + + // Type of new patch + patchInfo + { + type patch; + } + + // How to construct: either from 'patches' or 'set' + constructFrom set; + + // If constructFrom = set : name of faceSet + set f0; + } +); + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/extrudeToRegionMeshDictFilm b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/extrudeToRegionMeshDictFilm new file mode 100755 index 0000000000000000000000000000000000000000..77e4e801efc04234ad5c2ef5a69bc31cc0208766 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/extrudeToRegionMeshDictFilm @@ -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; + object extrudeToRegionMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +region filmRegion; + +faceZones (coupledWall); + +oneD false; + +sampleMode nearestPatchFace; + +extrudeModel linearNormal; + +nLayers 1; + +expansionRatio 1; + +adaptMesh false; // leave primary region patches intact + +linearNormalCoeffs +{ + thickness 0.001; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/extrudeToRegionMeshDictPyr b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/extrudeToRegionMeshDictPyr new file mode 100755 index 0000000000000000000000000000000000000000..4e723ce9ece155bbc0ffe6738413963b39529818 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/extrudeToRegionMeshDictPyr @@ -0,0 +1,40 @@ +/*--------------------------------*- 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 extrudeToRegionMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +region pyrolysisRegion; + +faceZones (coupledWall); + +oneD true; + +sampleMode nearestPatchFace; + +extrudeModel linearNormal; + +oneDPolyPatchType empty; + +nLayers 8; + +expansionRatio 1; + +adaptMesh true; // directMapped for both + +linearNormalCoeffs +{ + thickness 0.0039; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/changeDictionaryDict b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/changeDictionaryDict new file mode 100644 index 0000000000000000000000000000000000000000..edf40660b6f46dc7375e64b1bb2b62a6837bdbb4 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/changeDictionaryDict @@ -0,0 +1,29 @@ +/*--------------------------------*- 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 changeDictionaryDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dictionaryReplacement +{ + boundary + { + region0_to_filmRegion_coupledWall + { + samplePatch region0_to_pyrolysisRegion_coupledWall; + } + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/createPatchDict b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/createPatchDict new file mode 100644 index 0000000000000000000000000000000000000000..09a0c7f2dd0a1f643126d754d0c7bdef974b23bc --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/createPatchDict @@ -0,0 +1,73 @@ +/*--------------------------------*- 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 createPatchDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +matchTolerance 1E-3; + +pointSync false; + +patches +( + { + name outlet; + + patchInfo + { + type patch; + } + + constructFrom set; + + set f0; + } + { + name side1; + + patchInfo + { + type patch; + } + + constructFrom set; + + set f1; + } + { + name inlet; + + patchInfo + { + type patch; + } + + constructFrom set; + + set f2; + } + { + name side2; + + patchInfo + { + type patch; + } + + constructFrom set; + + set f3; + } +); + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSchemes b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSchemes new file mode 100755 index 0000000000000000000000000000000000000000..1af5787d81bf4741b38323fb60829dcbe31be9e1 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSchemes @@ -0,0 +1,53 @@ +/*--------------------------------*- 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/wallFilmRegion"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +divSchemes +{ + default none; + div(phi,Uf) Gauss upwind; + div(phid,deltaf) Gauss upwind; + div(phi,hf) Gauss upwind; +} + +gradSchemes +{ + default Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear uncorrected; +} + +snGradSchemes +{ + default uncorrected; +} + +fluxRequired +{ + default no; + deltaf; +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSolution b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSolution new file mode 100755 index 0000000000000000000000000000000000000000..9872d8c84cd90c45de1ab0a8d5b7e794ab091953 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/fvSolution @@ -0,0 +1,57 @@ +/*--------------------------------*- 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/wallFilmRegion"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + hf + { + solver PBiCG; + preconditioner DILU; + tolerance 0; + relTol 1e-3; + } + "(Uf|deltaf\*rhof)" + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-10; + relTol 0; + } + deltaf + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-10; + relTol 0; + } +} + + +PISO +{ + momentumPredictor true; + nOuterCorr 1; + nCorr 1; + nNonOrthCorr 0; + dfMin 1e-10; +} + + +relaxationFactors +{} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/topoSetDict b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/topoSetDict new file mode 100644 index 0000000000000000000000000000000000000000..0d88de754adcec893d38fdccafe188e998e48f0b --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/filmRegion/topoSetDict @@ -0,0 +1,66 @@ +/*--------------------------------*- 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 topoSetDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +actions +( + { + name f0; + type faceSet; + action new; + source boxToFace; + sourceInfo + { + box (-1 -0.00001 -0.00001) (1 1.00001 0.00001); + } + } + + + { + name f1; + type faceSet; + action new; + source boxToFace; + sourceInfo + { + box (-1 0.99999 -0.00001) (1 1.00001 2.00001); + } + } + + { + name f2; + type faceSet; + action new; + source boxToFace; + sourceInfo + { + box (-1 -0.00001 1.99999) (1 1.00001 2.00001); + } + } + + { + name f3; + type faceSet; + action new; + source boxToFace; + sourceInfo + { + box (-1 -0.00001 -0.00001) (1 0.00001 2.00001); + } + } +); + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSchemes b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSchemes new file mode 100755 index 0000000000000000000000000000000000000000..460de940322b0d141dacc278f04932ae51c13b3e --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSchemes @@ -0,0 +1,74 @@ +/*--------------------------------*- 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 Euler; +} + +gradSchemes +{ + default Gauss linear; +} + +divSchemes +{ + default none; + div(phi,U) Gauss filteredLinear2V 0.2 0.05; + div(phi,k) Gauss limitedLinear 1; + div(phi,K) Gauss limitedLinear 1; + div(phi,Yi_h) Gauss multivariateSelection + { + O2 limitedLinear01 1; + N2 limitedLinear01 1; + CH4 limitedLinear01 1; + C3H8 limitedLinear01 1; + CORRUGATED limitedLinear01 1; + CH2O limitedLinear01 1; + H2O limitedLinear01 1; + CO2 limitedLinear01 1; + h limitedLinear 1; + }; + + div((muEff*dev2(T(grad(U))))) Gauss linear; + div(phiU,p) Gauss linear; + div(Ji,Ii_h) Gauss upwind; +} + +laplacianSchemes +{ + default Gauss linear corrected; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default corrected; +} + +fluxRequired +{ + default no; + p_rgh; +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSolution b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSolution new file mode 100755 index 0000000000000000000000000000000000000000..c9c48e1c30d5406e140334924582d4d48c90fa5d --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/fvSolution @@ -0,0 +1,111 @@ +/*--------------------------------*- 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 PCG; + preconditioner DIC; + tolerance 0; + relTol 0.1; + }; + + rhoFinal + { + $rho; + tolerance 1e-6; + relTol 0; + }; + + p_rgh + { + solver GAMG; + tolerance 1e-5; + relTol 0.01; + smoother GaussSeidel; + cacheAgglomeration true; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + }; + + p_rghFinal + { + solver GAMG; + tolerance 1e-6; + relTol 0; + smoother GaussSeidel; + cacheAgglomeration true; + nCellsInCoarsestLevel 10; + //nCellsInCoarsestLevel 1; + agglomerator faceAreaPair; + mergeLevels 1; + }; + + "(U|Yi|h|k)" + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-8; + relTol 0.1; + }; + + "(U|Yi|h|k)Final" + { + $U; + tolerance 1e-8; + relTol 0; + }; + + Ii + { + solver GAMG; + tolerance 1e-4; + relTol 0; + smoother DILU; + cacheAgglomeration true; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + maxIter 20; + } +} + +PIMPLE +{ + momentumPredictor yes; + nOuterCorrectors 1; + nCorrectors 2; + nNonOrthogonalCorrectors 0; +} + +relaxationFactors +{ + fields + { + } + equations + { + "(U|k).*" 1; + "(C3H8|O2|H2O|CO2|h).*" 1; + } +} + + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSchemes b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSchemes new file mode 100755 index 0000000000000000000000000000000000000000..7ba1c2cc9d3e61f12a630003a6a8c55beaa363b2 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSchemes @@ -0,0 +1,54 @@ +/*--------------------------------*- 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 fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; +} + +divSchemes +{ + default none; +} + +laplacianSchemes +{ + default none; + laplacian(thermo:alpha,h) Gauss linear uncorrected; + laplacian(kappa,T) Gauss harmonic uncorrected; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default uncorrected; +} + +fluxRequired +{ + default no; +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSolution b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSolution new file mode 100755 index 0000000000000000000000000000000000000000..f40565020a70931fff74a9f4f2bf2c502a03e5e0 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/pyrolysisRegion/fvSolution @@ -0,0 +1,61 @@ +/*--------------------------------*- 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 fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + h + { + solver PCG; + preconditioner DIC; + tolerance 1e-06; + relTol 0; + } + + "Yi" + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-06; + relTol 0; + } + + "rho|rhot" + { + solver PCG; + preconditioner DIC; + tolerance 0; + relTol 0; + }; + +} + +SIMPLE +{ + nNonOrthCorr 0; +} + +relaxationFactors +{ + fields + { + } + equations + { + h 1; + } +} + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/topoSetDict b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/topoSetDict new file mode 100644 index 0000000000000000000000000000000000000000..2c4402d4bd62ebc88c7ae5569cf023487853866b --- /dev/null +++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/system/topoSetDict @@ -0,0 +1,55 @@ +/*--------------------------------*- 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 topoSetDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +actions +( + { + name f0; + type faceSet; + action new; + source boxToFace; + sourceInfo + { + box (-0.1 -2.1 -0.1)(0.201 2.51 0.01); + } + } + + + { + name coupledWall; + type faceSet; + action new; + source patchToFace; + sourceInfo + { + name coupledWallTmp; + } + } + + { + name coupledWall; + type faceZoneSet; + action new; + source setToFaceZone; + sourceInfo + { + faceSet coupledWall; + } + } +); + +// ************************************************************************* // diff --git a/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/Allrun b/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/Allrun index abde516d9c98828a50c6ca65366574d9fa653228..e7d3368b02fbebdb38ef8236c31ec80c16af63d7 100755 --- a/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/Allrun +++ b/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/Allrun @@ -4,15 +4,15 @@ cd ${0%/*} || exit 1 # run from this directory # Source tutorial run functions . $WM_PROJECT_DIR/bin/tools/RunFunctions -moveTimeMeshToConstant() -{ - DT=`foamInfoExec -times | tail -1` - if [ "$DT" != 0 ] - then - mv ${DT}/polyMesh/* constant/polyMesh - rm -rf ${DT} - fi -} +#moveTimeMeshToConstant() +#{ +# DT=`foamInfoExec -times | tail -1` +# if [ "$DT" != 0 ] +# then +# mv ${DT}/polyMesh/* constant/polyMesh +# rm -rf ${DT} +# fi +#} runApplication blockMesh @@ -20,8 +20,8 @@ runApplication datToFoam grid256.dat CONST="constant" cat $CONST/pointsHeader $CONST/points.tmp > $CONST/polyMesh/points -runApplication collapseEdges -moveTimeMeshToConstant +runApplication collapseEdges -overwrite +#moveTimeMeshToConstant echo "Changing patch type to wedge type in boundary file" mv $CONST/polyMesh/boundary $CONST/polyMesh/boundary.bak diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/createBafflesDict b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/createBafflesDict index 0fb9d229742229e6b760a243b1add899a4d47823..347a7444d46b3fb1f0e7c992c07c1b975e201dd6 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/createBafflesDict +++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/createBafflesDict @@ -30,9 +30,6 @@ baffles zoneName baffleFaces; - //- Optional flip - //flip false; - patches { master @@ -42,9 +39,7 @@ baffles type mappedWall; sampleMode nearestPatchFace; - sampleRegion region0; samplePatch baffle1Wall_1; - offsetMode uniform; offset (0 0 0); @@ -121,9 +116,7 @@ baffles type mappedWall; sampleMode nearestPatchFace; - sampleRegion region0; samplePatch baffle1Wall_0; - offsetMode uniform; offset (0 0 0); patchFields diff --git a/tutorials/multiphase/twoPhaseEulerFoam/LES/bubbleColumn/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/LES/bubbleColumn/system/fvSchemes index f55c52ee564855bde82231ad16e98d275780af37..0c84553dbc46a185e94d5a3566429c14cd6a9c71 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/LES/bubbleColumn/system/fvSchemes +++ b/tutorials/multiphase/twoPhaseEulerFoam/LES/bubbleColumn/system/fvSchemes @@ -34,7 +34,7 @@ divSchemes "div\(alphaPhi.*,U.*\)" Gauss limitedLinearV 1; "div\(phi.*,U.*\)" Gauss limitedLinearV 1; - "div\(phi.*,.*rho.*\)" Gauss linear; + "div\(alphaPhi.*,.*rho.*\)" Gauss linear; "div\(alphaPhi.*,(h|e).*\)" Gauss limitedLinear 1; "div\(alphaPhi.*,(K.*|p)\)" Gauss limitedLinear 1; diff --git a/tutorials/multiphase/twoPhaseEulerFoam/RAS/bubbleColumn/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/RAS/bubbleColumn/system/fvSchemes index d3f22a16e83654868ecdc438167a2bd61f8df600..0ccc0c9b67888ba13c9ec849500c9b1e08d8fc52 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/RAS/bubbleColumn/system/fvSchemes +++ b/tutorials/multiphase/twoPhaseEulerFoam/RAS/bubbleColumn/system/fvSchemes @@ -34,7 +34,7 @@ divSchemes "div\(alphaPhi.*,U.*\)" Gauss limitedLinearV 1; "div\(phi.*,U.*\)" Gauss limitedLinearV 1; - "div\(phi.*,.*rho.*\)" Gauss linear; + "div\(alphaPhi.*,.*rho.*\)" Gauss linear; "div\(alphaPhi.*,(h|e).*\)" Gauss limitedLinear 1; "div\(alphaPhi.*,(K.*|p)\)" Gauss limitedLinear 1; diff --git a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/T.particles b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/T.particles index 155187199907bcc1ea0a526baea46812b3b29d63..58313dfb2b5c6f5d87e45ee056240033c9e61406 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/T.particles +++ b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/T.particles @@ -22,16 +22,12 @@ boundaryField { inlet { - type fixedValue; - value $internalField; + type zeroGradient; } outlet { - type inletOutlet; - phi phi.particles; - inletValue $internalField; - value $internalField; + type zeroGradient; } walls diff --git a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/U.air b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/U.air index 4896cfb962a47eebb1ef639ae307045472f49060..a9af55993e23ff26e112eb927135b6667f7d6f45 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/U.air +++ b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/U.air @@ -22,8 +22,10 @@ boundaryField { inlet { - type fixedValue; - value uniform (0 0.25 0); + type interstitialInletVelocity; + inletVelocity uniform (0 0.25 0); + alpha alpha.air; + value $internalField; } outlet diff --git a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/alpha.particles.org b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/alpha.particles.org index 69666444bc1beb16275c2ac20a69f6c41cd4252e..b28a5a97d9b1034a39925ead65f04cd371860b89 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/alpha.particles.org +++ b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/0/alpha.particles.org @@ -22,8 +22,7 @@ boundaryField { inlet { - type fixedValue; - value uniform 0; + type zeroGradient; } outlet diff --git a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSchemes index 2546db411275847e1db31badc51db945562292ac..1c6548cac37c3d48da4c96941dfb5f51b1683442 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSchemes +++ b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSchemes @@ -34,7 +34,7 @@ divSchemes "div\(alphaPhi.*,U.*\)" Gauss limitedLinearV 1; "div\(phi.*,U.*\)" Gauss limitedLinearV 1; - "div\(phi.*,.*rho.*\)" Gauss linear; + "div\(alphaPhi.*,.*rho.*\)" Gauss linear; "div\(alphaPhi.*,(h|e).*\)" Gauss limitedLinear 1; "div\(alphaPhi.*,(K.*|p)\)" Gauss limitedLinear 1; diff --git a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSolution b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSolution index 894a1d3dde695dfefc79feee9f4dc781e88a905d..f5519a78a9b0119de56bfc6b6d2d03dc34d8bf2d 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSolution +++ b/tutorials/multiphase/twoPhaseEulerFoam/RAS/fluidisedBed/system/fvSolution @@ -87,7 +87,7 @@ solvers PIMPLE { nOuterCorrectors 1; - nCorrectors 3; + nCorrectors 2; nNonOrthogonalCorrectors 0; } diff --git a/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSchemes index 549178c4c6d23cc27d375e5f3ec2f1c7084672ee..0bd5b9026ec94c19b121fe86056002cf740600e8 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSchemes +++ b/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSchemes @@ -34,7 +34,7 @@ divSchemes "div\(alphaPhi.*,U.*\)" Gauss limitedLinearV 1; "div\(phi.*,U.*\)" Gauss limitedLinearV 1; - "div\(phi.*,.*rho.*\)" Gauss linear; + "div\(alphaPhi.*,.*rho.*\)" Gauss linear; "div\(alphaPhi.*,(h|e).*\)" Gauss limitedLinear 1; "div\(alphaPhi.*,(K.*|p)\)" Gauss limitedLinear 1; diff --git a/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSolution b/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSolution index 6e38c9cc85f6257bff5c7408a589a29ee25271f3..a25ccff8c62a0d6c8289dc37ad95385ffaaaf771 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSolution +++ b/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumn/system/fvSolution @@ -17,7 +17,7 @@ FoamFile solvers { - alpha + alpha.air { nAlphaCorr 1; nAlphaSubCycles 2; diff --git a/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumnIATE/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumnIATE/system/fvSchemes index 3fd8876cb600ec235534eb44522c437e989fb8df..c405673fdaadf30aa5668d1f433553970e5ebf59 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumnIATE/system/fvSchemes +++ b/tutorials/multiphase/twoPhaseEulerFoam/laminar/bubbleColumnIATE/system/fvSchemes @@ -36,7 +36,7 @@ divSchemes "div\(alphaPhi.*,U.*\)" Gauss limitedLinearV 1; "div\(phi.*,U.*\)" Gauss limitedLinearV 1; - "div\(phi.*,.*rho.*\)" Gauss linear; + "div\(alphaPhi.*,.*rho.*\)" Gauss linear; "div\(alphaPhi.*,(h|e).*\)" Gauss limitedLinear 1; "div\(alphaPhi.*,(K.*|p)\)" Gauss limitedLinear 1; diff --git a/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSchemes index 9fc65bf8cbc74f0036a8175ef25d5f528fb57565..0360d1b8ce1d847bad66314a1e19d67cd5add7c7 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSchemes +++ b/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSchemes @@ -34,7 +34,7 @@ divSchemes "div\(alphaPhi.*,U.*\)" Gauss limitedLinearV 1; "div\(phi.*,U.*\)" Gauss limitedLinearV 1; - "div\(phi.*,.*rho.*\)" Gauss linear; + "div\(alphaPhi.*,.*rho.*\)" Gauss linear; "div\(alphaPhi.*,(h|e).*\)" Gauss limitedLinear 1; "div\(alphaPhi.*,(K.*|p)\)" Gauss limitedLinear 1; diff --git a/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSolution b/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSolution index 894a1d3dde695dfefc79feee9f4dc781e88a905d..f5519a78a9b0119de56bfc6b6d2d03dc34d8bf2d 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSolution +++ b/tutorials/multiphase/twoPhaseEulerFoam/laminar/fluidisedBed/system/fvSolution @@ -87,7 +87,7 @@ solvers PIMPLE { nOuterCorrectors 1; - nCorrectors 3; + nCorrectors 2; nNonOrthogonalCorrectors 0; } diff --git a/tutorials/multiphase/twoPhaseEulerFoam/laminar/mixerVessel2D/system/fvSchemes b/tutorials/multiphase/twoPhaseEulerFoam/laminar/mixerVessel2D/system/fvSchemes index c29b10072aedbfddf0ac04218b035914f8091684..61f5962400d0546881c35db9f00fdd5ec799191d 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/laminar/mixerVessel2D/system/fvSchemes +++ b/tutorials/multiphase/twoPhaseEulerFoam/laminar/mixerVessel2D/system/fvSchemes @@ -34,7 +34,7 @@ divSchemes "div\(alphaPhi.*,U.*\)" Gauss limitedLinearV 1; "div\(phi.*,U.*\)" Gauss limitedLinearV 1; - "div\(phi.*,.*rho.*\)" Gauss linear; + "div\(alphaPhi.*,.*rho.*\)" Gauss linear; "div\(alphaPhi.*,(h|e).*\)" Gauss limitedLinear 1; "div\(alphaPhi.*,(K.*|p)\)" Gauss limitedLinear 1;