diff --git a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H index 67788bd3c7..bbe654639d 100644 --- a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H +++ b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H @@ -55,7 +55,7 @@ Description In between ratio 0 and 1 the gradient and value contributions are weighted using the ratio field in the followig way: - qConv = ratio*htcwfilm*(Tfilm - *this)*convectiveScaling_; + qConv = ratio*htcwfilm*(Tfilm - *this); qRad = (1.0 - ratio)*Qr; Then the solid can gain or loose energy through radiation or conduction diff --git a/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H b/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H index 7516656350..1cfeeb7488 100644 --- a/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H +++ b/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -39,112 +39,114 @@ Description - 2-D, normal and tangential components The thermodynamic properties of the baffle material are specified via - dictionary entries. + dictionary entries on the master patch \heading Patch usage Example of the boundary condition specification: \verbatim - myPatch + myPatch_master { - type compressible::temperatureThermoBaffle; + type compressible::thermalBaffle; // Underlaying coupled boundary condition - Tnbr T; - kappa fluidThermo; // or solidThermo - KappaName none; - QrNbr Qr;//or none.Name of Qr field on neighbourregion - Qr none;// or none.Name of Qr field on localregion - value uniform 300; + Tnbr T; + kappa fluidThermo; // or solidThermo + KappaName none; + QrNbr Qr;//or none.Name of Qr field on neighbourregion + Qr none;// or none.Name of Qr field on localregion + value uniform 300; - // Thermo baffle model - regionName baffleRegion; // solid region name - infoOutput yes; - active yes; + // Baffle region name + regionName baffleRegion; + active yes; // Solid thermo in solid region - thermoType - { - type heSolidThermo; - mixture pureSolidMixture; - transport constIso; - thermo hConst; - equationOfState rhoConst; - specie specie; - energy sensibleEnthalpy; - } + thermoType + { + type heSolidThermo; + mixture pureMixture; + transport constIso; + thermo hConst; + equationOfState rhoConst; + specie specie; + energy sensibleEnthalpy; + } - mixture + mixture + { + specie { - specie - { - nMoles 1; - molWeight 20; - } - transport - { - kappa 0.01; - } - thermodynamics - { - Hf 0; - Cp 15; - } - density - { - rho 80; - } + nMoles 1; + molWeight 20; } + transport + { + kappa 0.01; + } + thermodynamics + { + Hf 0; + Cp 15; + } + density + { + rho 80; + } + } - radiation - { - radiationModel opaqueSolid; - absorptionEmissionModel none; - scatterModel none; - } + radiation + { + radiationModel opaqueSolid; + absorptionEmissionModel none; + scatterModel none; + } // Extrude model for new region - extrudeModel linearNormal; - nLayers 50; - expansionRatio 1; - columnCells false; //3D or 1D - linearNormalCoeffs - { - thickness 0.02; - } + extrudeModel linearNormal; + nLayers 50; + expansionRatio 1; + columnCells false; //3D or 1D + linearNormalCoeffs + { + thickness 0.02; + } - - // New mesh polyPatch information - - bottomCoeffs - { - name "bottom"; - type mappedWall; - sampleMode nearestPatchFace; - samplePatch baffle3DWall_master; - offsetMode uniform; - offset (0 0 0); - } - - topCoeffs - { - name "top"; - type mappedWall; - sampleMode nearestPatchFace; - samplePatch baffle3DWall_slave; - offsetMode uniform; - offset (0 0 0); - } - - sideCoeffs - { - name "side"; - type patch; - } } \endverbatim + /- Slave patch on primary region + \verbatim + myPatch_slave + { + type compressible::thermalBaffle; + kappa fluidThermo; + kappaName none; + value uniform 300; + \endverbatim + + + /- Patches on baffle region + \verbatim + bottom + { + type compressible::thermalBaffle; + kappa solidThermo; + kappaName none; + value uniform 300; + } + + top + { + type compressible::thermalBaffle; + kappa solidThermo; + kappaName none; + value uniform 300; + } + \endverbatim + + SeeAlso Foam::turbulentTemperatureCoupledBaffleMixedFvPatchScalarField Foam::regionModels::thermalBaffleModels::thermalBaffleModel diff --git a/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.C b/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.C index 66cdfb99ad..6e095a1b94 100644 --- a/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.C +++ b/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.C @@ -26,6 +26,7 @@ License #include "radiationModel.H" #include "absorptionEmissionModel.H" #include "scatterModel.H" +#include "sootModel.H" #include "fvmSup.H" #include "fluidThermo.H" @@ -83,6 +84,8 @@ void Foam::radiation::radiationModel::initialise() ); scatter_.reset(scatterModel::New(*this, mesh_).ptr()); + + soot_.reset(sootModel::New(*this, mesh_).ptr()); } } @@ -110,7 +113,8 @@ Foam::radiation::radiationModel::radiationModel(const volScalarField& T) solverFreq_(0), firstIter_(true), absorptionEmission_(NULL), - scatter_(NULL) + scatter_(NULL), + soot_(NULL) {} @@ -129,7 +133,8 @@ Foam::radiation::radiationModel::radiationModel solverFreq_(1), firstIter_(true), absorptionEmission_(NULL), - scatter_(NULL) + scatter_(NULL), + soot_(NULL) { if (readOpt() == IOobject::NO_READ) { @@ -167,7 +172,8 @@ Foam::radiation::radiationModel::radiationModel solverFreq_(1), firstIter_(true), absorptionEmission_(NULL), - scatter_(NULL) + scatter_(NULL), + soot_(NULL) { initialise(); } @@ -212,6 +218,11 @@ void Foam::radiation::radiationModel::correct() calculate(); firstIter_ = false; } + + if (!soot_.empty()) + { + soot_->correct(); + } } @@ -265,4 +276,22 @@ Foam::radiation::radiationModel::absorptionEmission() const } +const Foam::radiation::sootModel& +Foam::radiation::radiationModel::soot() const +{ + if (!soot_.valid()) + { + FatalErrorIn + ( + "const Foam::radiation::sootModel&" + "Foam::radiation::radiationModel::soot() const" + ) + << "Requested radiation sootModel model, but model is " + << "not activate" << abort(FatalError); + } + + return soot_(); +} + + // ************************************************************************* // diff --git a/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.H b/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.H index 001a7839e7..a963feb2a0 100644 --- a/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.H +++ b/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.H @@ -64,6 +64,7 @@ namespace radiation // Forward declaration of classes class absorptionEmissionModel; class scatterModel; +class sootModel; /*---------------------------------------------------------------------------*\ Class radiationModel Declaration @@ -108,6 +109,9 @@ protected: //- Scatter model autoPtr scatter_; + //- Soot model + autoPtr soot_; + private: @@ -232,6 +236,9 @@ public: //- Access to absorptionEmission model const absorptionEmissionModel& absorptionEmission() const; + + //- Access to soot Model + const sootModel& soot() const; }; diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H index 7a9f0f1d7e..bed019f4bd 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H +++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C index 0267cac34c..4b1eea216f 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C +++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,7 +47,10 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField : mixedFvPatchScalarField(p, iF), temperatureCoupledBase(patch(), "undefined", "undefined-K"), - TnbrName_("undefined-Tnbr") + TnbrName_("undefined-Tnbr"), + thicknessLayers_(0), + kappaLayers_(0), + contactRes_(0) { this->refValue() = 0.0; this->refGrad() = 0.0; @@ -66,7 +69,10 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField : mixedFvPatchScalarField(ptf, p, iF, mapper), temperatureCoupledBase(patch(), ptf.KMethod(), ptf.kappaName()), - TnbrName_(ptf.TnbrName_) + TnbrName_(ptf.TnbrName_), + thicknessLayers_(ptf.thicknessLayers_), + kappaLayers_(ptf.kappaLayers_), + contactRes_(ptf.contactRes_) {} @@ -80,7 +86,10 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField : mixedFvPatchScalarField(p, iF), temperatureCoupledBase(patch(), dict), - TnbrName_(dict.lookup("Tnbr")) + TnbrName_(dict.lookup("Tnbr")), + thicknessLayers_(0), + kappaLayers_(0), + contactRes_(0.0) { if (!isA(this->patch().patch())) { diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C index 7f1b0b232f..863ba3a4f3 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C +++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -50,8 +50,8 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField TnbrName_("undefined-Tnbr"), QrNbrName_("undefined-QrNbr"), QrName_("undefined-Qr"), - thicknessLayers_(), - kappaLayers_(), + thicknessLayers_(0), + kappaLayers_(0), contactRes_(0) { this->refValue() = 0.0; @@ -93,8 +93,8 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField TnbrName_(dict.lookupOrDefault("Tnbr", "T")), QrNbrName_(dict.lookupOrDefault("QrNbr", "none")), QrName_(dict.lookupOrDefault("Qr", "none")), - thicknessLayers_(), - kappaLayers_(), + thicknessLayers_(0), + kappaLayers_(0), contactRes_(0.0) { if (!isA(this->patch().patch())) diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/radiationProperties b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/radiationProperties index 18b20332bb..71abc0f0fa 100644 --- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/radiationProperties +++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/radiationProperties @@ -16,14 +16,15 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +radiation on; + radiationModel opaqueSolid; absorptionEmissionModel greyMeanSolidAbsorptionEmission; - greyMeanSolidAbsorptionEmissionCoeffs { - wood + wood { absorptivity 0.17; emissivity 0.17; diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution index 7345991f71..a95844ff60 100644 --- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution +++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/fvSolution @@ -34,7 +34,7 @@ solvers p_rgh { solver GAMG; - tolerance 1e-7; + tolerance 1e-6; relTol 0.01; smoother GaussSeidel; cacheAgglomeration true; @@ -46,7 +46,7 @@ solvers p_rghFinal { $p_rgh; - tolerance 1e-7; + tolerance 1e-6; relTol 0; }; @@ -55,7 +55,7 @@ solvers { solver PBiCG; preconditioner DILU; - tolerance 1e-7; + tolerance 1e-6; relTol 0.1; nSweeps 1; }; @@ -63,32 +63,24 @@ solvers "(U|Yi|k|h|omega)Final" { $U; - tolerance 1e-7; + tolerance 1e-6; relTol 0; }; - "(h|hFinal|Yi)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-8; - relTol 0; - }; - Ii { - solver GAMG; - tolerance 1e-4; - relTol 0; - smoother symGaussSeidel; - cacheAgglomeration true; + solver GAMG; + tolerance 1e-4; + relTol 0; + smoother symGaussSeidel; + cacheAgglomeration true; nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - maxIter 1; - nPreSweeps 0; - nPostSweeps 1; + agglomerator faceAreaPair; + mergeLevels 1; + maxIter 1; + nPreSweeps 0; + nPostSweeps 1; } "(G)Final" @@ -105,7 +97,7 @@ PIMPLE { momentumPredictor yes; nOuterCorrectors 1; - nCorrectors 3; + nCorrectors 2; nNonOrthogonalCorrectors 0; } diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSchemes b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSchemes index 7ba1c2cc9d..405227e503 100644 --- a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSchemes +++ b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/system/panelRegion/fvSchemes @@ -32,18 +32,18 @@ divSchemes laplacianSchemes { default none; - laplacian(thermo:alpha,h) Gauss linear uncorrected; - laplacian(kappa,T) Gauss harmonic uncorrected; + laplacian(thermo:alpha,h) Gauss linear corrected; + laplacian(kappa,T) Gauss harmonic corrected; } interpolationSchemes { - default linear; + default linear; } snGradSchemes { - default uncorrected; + default corrected; } fluxRequired diff --git a/tutorials/combustion/fireFoam/les/smallPoolFire2D/0/soot b/tutorials/combustion/fireFoam/les/smallPoolFire2D/0/soot index 427d4f2d00..cc500661a9 100644 --- a/tutorials/combustion/fireFoam/les/smallPoolFire2D/0/soot +++ b/tutorials/combustion/fireFoam/les/smallPoolFire2D/0/soot @@ -23,7 +23,7 @@ boundaryField { ".*" { - type calculate; + type calculated; } frontAndBack diff --git a/tutorials/combustion/fireFoam/les/smallPoolFire2D/constant/polyMesh/boundary b/tutorials/combustion/fireFoam/les/smallPoolFire2D/constant/polyMesh/boundary new file mode 100644 index 0000000000..6a17bae1f0 --- /dev/null +++ b/tutorials/combustion/fireFoam/les/smallPoolFire2D/constant/polyMesh/boundary @@ -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 polyBoundaryMesh; + location "constant/polyMesh"; + object boundary; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +5 +( + base + { + type patch; + nFaces 134; + startFace 44700; + } + outlet + { + type patch; + nFaces 150; + startFace 44834; + } + sides + { + type patch; + nFaces 300; + startFace 44984; + } + frontAndBack + { + type empty; + inGroups 1(empty); + nFaces 45000; + startFace 45284; + } + inlet + { + type patch; + nFaces 16; + startFace 90284; + } +) + +// ************************************************************************* // diff --git a/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution b/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution index fba625916d..1dc27ec72b 100644 --- a/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution +++ b/tutorials/combustion/fireFoam/les/smallPoolFire2D/system/fvSolution @@ -22,22 +22,22 @@ solvers { solver PCG; preconditioner DIC; - tolerance 1e-7; + tolerance 1e-6; relTol 0.1; }; rhoFinal { $rho; - tolerance 1e-7; + tolerance 1e-6; relTol 0; }; p_rgh { solver GAMG; - tolerance 1e-7; - relTol 0.01; + tolerance 1e-6; + relTol 0.05; smoother GaussSeidel; cacheAgglomeration true; nCellsInCoarsestLevel 10; @@ -48,7 +48,7 @@ solvers p_rghFinal { $p_rgh; - tolerance 1e-7; + tolerance 1e-6; relTol 0; }; @@ -57,7 +57,7 @@ solvers { solver PBiCG; preconditioner DILU; - tolerance 1e-7; + tolerance 1e-6; relTol 0.1; nSweeps 1; }; @@ -65,24 +65,24 @@ solvers "(U|Yi|k|h|omega)Final" { $U; - tolerance 1e-7; + tolerance 1e-6; relTol 0; }; Ii { - solver GAMG; - tolerance 1e-4; - relTol 0.1; - smoother symGaussSeidel; - cacheAgglomeration true; + solver GAMG; + tolerance 1e-4; + relTol 0.1; + smoother symGaussSeidel; + cacheAgglomeration true; nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - maxIter 3; - nPreSweeps 0; - nPostSweeps 1; + agglomerator faceAreaPair; + mergeLevels 1; + maxIter 3; + nPreSweeps 0; + nPostSweeps 1; } G diff --git a/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/controlDict b/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/controlDict index 6f9c9cf1e6..bae6296f20 100644 --- a/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/controlDict +++ b/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/controlDict @@ -22,13 +22,13 @@ startTime 0.0; stopAt endTime; -endTime 0.75; +endTime 4.0; deltaT 0.001; writeControl adjustableRunTime; -writeInterval 0.5; +writeInterval 0.1; purgeWrite 0; @@ -48,7 +48,7 @@ runTimeModifiable yes; adjustTimeStep yes; -maxCo 0.5; +maxCo 0.6; maxDeltaT 0.1; diff --git a/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution b/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution index 11cfaf95bd..e3c8b37589 100644 --- a/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution +++ b/tutorials/combustion/fireFoam/les/smallPoolFire3D/system/fvSolution @@ -21,14 +21,14 @@ solvers { solver PCG; preconditioner DIC; - tolerance 1e-7; + tolerance 1e-6; relTol 0; }; p_rgh { solver GAMG; - tolerance 1e-7; + tolerance 1e-6; relTol 0.1; smoother GaussSeidel; cacheAgglomeration true; @@ -40,7 +40,7 @@ solvers p_rghFinal { $p_rgh; - tolerance 1e-8; + tolerance 1e-6; relTol 0; }; @@ -49,7 +49,7 @@ solvers { solver PBiCG; preconditioner DILU; - tolerance 1e-7; + tolerance 1e-6; relTol 0.1; nSweeps 1; }; @@ -57,7 +57,7 @@ solvers "(U|Yi|k|h)Final" { $U; - tolerance 1e-8; + tolerance 1e-6; relTol 0; }; @@ -90,7 +90,7 @@ PIMPLE { momentumPredictor yes; nOuterCorrectors 1; - nCorrectors 3; + nCorrectors 2; nNonOrthogonalCorrectors 0; } diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/thermophysicalProperties b/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/constant/polyMesh/boundary similarity index 55% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/thermophysicalProperties rename to tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/constant/polyMesh/boundary index df146b74f3..0e07c61c65 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/thermophysicalProperties +++ b/tutorials/heatTransfer/buoyantSimpleFoam/buoyantCavity/constant/polyMesh/boundary @@ -9,45 +9,42 @@ FoamFile { version 2.0; format ascii; - class dictionary; - object thermophysicalProperties; + class polyBoundaryMesh; + location "constant/polyMesh"; + object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -thermoType -{ - type heSolidThermo; - mixture pureMixture; - transport constIso; - thermo hConst; - equationOfState rhoConst; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie +4 +( + frontAndBack { - nMoles 1; - molWeight 12; + type wall; + inGroups 1(wall); + nFaces 1050; + startFace 228225; } - - transport + topAndBottom { - kappa 80; + type wall; + inGroups 1(wall); + nFaces 10500; + startFace 229275; } - - thermodynamics + hot { - Hf 0; - Cp 450; + type wall; + inGroups 1(wall); + nFaces 2250; + startFace 239775; } - - equationOfState + cold { - rho 8000; + type wall; + inGroups 1(wall); + nFaces 2250; + startFace 242025; } -} +) // ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes index 0145c8e18b..9881bbd431 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes +++ b/tutorials/heatTransfer/buoyantSimpleFoam/circuitBoardCooling/system/fvSchemes @@ -16,12 +16,12 @@ FoamFile ddtSchemes { - default steadyState; + default steadyState; } gradSchemes { - default Gauss linear; + default Gauss linear; } divSchemes diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/thermophysicalProperties b/tutorials/heatTransfer/buoyantSimpleFoam/externalCoupledCavity/constant/polyMesh/boundary similarity index 55% rename from tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/thermophysicalProperties rename to tutorials/heatTransfer/buoyantSimpleFoam/externalCoupledCavity/constant/polyMesh/boundary index df146b74f3..0e07c61c65 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/thermophysicalProperties +++ b/tutorials/heatTransfer/buoyantSimpleFoam/externalCoupledCavity/constant/polyMesh/boundary @@ -9,45 +9,42 @@ FoamFile { version 2.0; format ascii; - class dictionary; - object thermophysicalProperties; + class polyBoundaryMesh; + location "constant/polyMesh"; + object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -thermoType -{ - type heSolidThermo; - mixture pureMixture; - transport constIso; - thermo hConst; - equationOfState rhoConst; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie +4 +( + frontAndBack { - nMoles 1; - molWeight 12; + type wall; + inGroups 1(wall); + nFaces 1050; + startFace 228225; } - - transport + topAndBottom { - kappa 80; + type wall; + inGroups 1(wall); + nFaces 10500; + startFace 229275; } - - thermodynamics + hot { - Hf 0; - Cp 450; + type wall; + inGroups 1(wall); + nFaces 2250; + startFace 239775; } - - equationOfState + cold { - rho 8000; + type wall; + inGroups 1(wall); + nFaces 2250; + startFace 242025; } -} +) // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/polyMesh/boundary b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/constant/polyMesh/boundary similarity index 69% rename from tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/polyMesh/boundary rename to tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/constant/polyMesh/boundary index 73459cea07..dd60bda33a 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/polyMesh/boundary +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/constant/polyMesh/boundary @@ -15,43 +15,35 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -6 +4 ( - maxY + box { type wall; + inGroups 1(wall); nFaces 300; - startFace 8300; + startFace 303675; } - minX - { - type patch; - nFaces 100; - startFace 8600; - } - maxX - { - type patch; - nFaces 100; - startFace 8700; - } - minY + floor { type wall; - nFaces 300; - startFace 8800; + inGroups 1(wall); + nFaces 5125; + startFace 303975; } - minZ + ceiling { type wall; - nFaces 300; - startFace 9100; + inGroups 1(wall); + nFaces 5225; + startFace 309100; } - maxZ + fixedWalls { type wall; - nFaces 300; - startFace 9400; + inGroups 1(wall); + nFaces 6000; + startFace 314325; } ) diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/constant/radiationProperties b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/constant/radiationProperties index 2bc00e760c..6f84aac5bc 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/constant/radiationProperties +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoom/constant/radiationProperties @@ -15,6 +15,8 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +radiation on; + radiationModel P1; // Number of flow iterations per radiation iteration @@ -26,10 +28,12 @@ constantAbsorptionEmissionCoeffs { absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.5; emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.5; - E E [ 1 -1 -3 0 0 0 0 ] 0; + E E [ 1 -1 -3 0 0 0 0 ] 0; } scatterModel none; +sootModel none; + // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/polyMesh/boundary b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/constant/polyMesh/boundary similarity index 69% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/polyMesh/boundary rename to tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/constant/polyMesh/boundary index 68bdec8486..8cff40253e 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/polyMesh/boundary +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/constant/polyMesh/boundary @@ -15,43 +15,35 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -6 +4 ( - maxY + box { type wall; + inGroups 1(wall); nFaces 300; - startFace 8300; + startFace 303675; } - minX - { - type patch; - nFaces 100; - startFace 8600; - } - maxX - { - type patch; - nFaces 100; - startFace 8700; - } - minY + floor { type wall; - nFaces 300; - startFace 8800; + inGroups 1(wall); + nFaces 5125; + startFace 303975; } - minZ + ceiling { type wall; - nFaces 300; - startFace 9100; + inGroups 1(wall); + nFaces 5225; + startFace 309100; } - maxZ + fixedWalls { type wall; - nFaces 300; - startFace 9400; + inGroups 1(wall); + nFaces 6000; + startFace 314325; } ) diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/constant/radiationProperties b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/constant/radiationProperties index 2f30a68642..76bbe562b8 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/constant/radiationProperties +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/constant/radiationProperties @@ -15,14 +15,17 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +radiation on; + radiationModel fvDOM; fvDOMCoeffs { - nPhi 3; // azimuthal angles in PI/2 on X-Y.(from Y to X) - nTheta 5; // polar angles in PI (from Z to X-Y plane) + nPhi 3; // azimuthal angles in PI/2 on X-Y.(from Y to X) + nTheta 5; // polar angles in PI (from Z to X-Y plane) convergence 1e-3; // convergence criteria for radiation iteration - maxIter 10; // maximum number of iterations + maxIter 10; // maximum number of iterations + cacheDiv false; } // Number of flow iterations per radiation iteration @@ -32,12 +35,13 @@ absorptionEmissionModel constantAbsorptionEmission; constantAbsorptionEmissionCoeffs { - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.01; - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.01; - E E [ 1 -1 -3 0 0 0 0 ] 0; + absorptivity absorptivity [ m^-1 ] 0.5; + emissivity emissivity [ m^-1 ] 0.5; + E E [ kg m^-1 s^-3 ] 0; } scatterModel none; +sootModel none; // ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSchemes index c36da33bd6..e0a0f4efd2 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSchemes +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSchemes @@ -33,7 +33,7 @@ divSchemes div(phi,h) bounded Gauss upwind; div(phi,k) bounded Gauss upwind; div(phi,epsilon) bounded Gauss upwind; - div(Ji,Ii_h) Gauss linearUpwind grad(Ii_h); + div(Ji,Ii_h) bounded Gauss linearUpwind grad(Ii_h); div((muEff*dev2(T(grad(U))))) Gauss linear; } diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution index f3fc1aee13..8ce57081a3 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution +++ b/tutorials/heatTransfer/buoyantSimpleFoam/hotRadiationRoomFvDOM/system/fvSolution @@ -19,17 +19,28 @@ solvers { p_rgh { - solver GAMG; + solver PCG; + preconditioner DIC; tolerance 1e-06; relTol 0.01; - smoother GaussSeidel; - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; } - "(U|h|k|epsilon|Ii)" + Ii + { + solver GAMG; + tolerance 1e-4; + relTol 0; + smoother symGaussSeidel; + cacheAgglomeration true; + nCellsInCoarsestLevel 10; + agglomerator faceAreaPair; + mergeLevels 1; + maxIter 5; + nPreSweeps 0; + nPostSweeps 1; + } + + "(U|h|k|epsilon)" { solver PBiCG; preconditioner DILU; @@ -53,6 +64,7 @@ SIMPLE // possibly check turbulence fields "(k|epsilon|omega)" 1e-3; + "ILambda.*" 1e-3; } } @@ -61,14 +73,14 @@ relaxationFactors fields { rho 1.0; - p_rgh 0.3; + p_rgh 0.7; } equations { - U 0.7; - h 0.7; - k 0.7; - epsilon 0.7; + U 0.2; + h 0.2; + k 0.5; + epsilon 0.5; "ILambda.*" 0.7; } } diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/T b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/T deleted file mode 100644 index ae7aa33db2..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/T +++ /dev/null @@ -1,39 +0,0 @@ -/*--------------------------------*- 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 T; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 1 0 0 0]; - -internalField uniform 300; - -boundaryField -{ - floor - { - type fixedValue; - value uniform 300; - } - ceiling - { - type fixedValue; - value uniform 300; - } - fixedWalls - { - type zeroGradient; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/T.org b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/T.org deleted file mode 100644 index ae7aa33db2..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/T.org +++ /dev/null @@ -1,39 +0,0 @@ -/*--------------------------------*- 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 T; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 1 0 0 0]; - -internalField uniform 300; - -boundaryField -{ - floor - { - type fixedValue; - value uniform 300; - } - ceiling - { - type fixedValue; - value uniform 300; - } - fixedWalls - { - type zeroGradient; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/p b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/p deleted file mode 100644 index 5c26f07ac4..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/p +++ /dev/null @@ -1,42 +0,0 @@ -/*--------------------------------*- 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 p; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [1 -1 -2 0 0 0 0]; - -internalField uniform 1e5; - -boundaryField -{ - floor - { - type calculated; - value $internalField; - } - - ceiling - { - type calculated; - value $internalField; - } - - fixedWalls - { - type calculated; - value $internalField; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/Allclean b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/Allclean deleted file mode 100755 index 25243dd42f..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/Allclean +++ /dev/null @@ -1,10 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory - -# Source tutorial clean functions -. $WM_PROJECT_DIR/bin/tools/CleanFunctions - -cleanCase -cp 0/T.org 0/T - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/Allrun b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/Allrun deleted file mode 100755 index 7b90a31601..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/Allrun +++ /dev/null @@ -1,13 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory - -# Source tutorial run functions -. $WM_PROJECT_DIR/bin/tools/RunFunctions - -application=`getApplication` - -runApplication blockMesh -runApplication setFields -runApplication $application - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/RASProperties b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/RASProperties deleted file mode 100644 index a4937b503a..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/RASProperties +++ /dev/null @@ -1,25 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel kEpsilon; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/g b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/g deleted file mode 100644 index 037e3b47f3..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/g +++ /dev/null @@ -1,21 +0,0 @@ -/*--------------------------------*- 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 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/polyMesh/blockMeshDict b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/polyMesh/blockMeshDict deleted file mode 100644 index 57a82196c9..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/polyMesh/blockMeshDict +++ /dev/null @@ -1,75 +0,0 @@ -/*--------------------------------*- 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) - (10 0 0) - (10 5 0) - (0 5 0) - (0 0 10) - (10 0 10) - (10 5 10) - (0 5 10) -); - -blocks -( - hex (0 1 2 3 4 5 6 7) (20 10 20) simpleGrading (1 1 1) -); - -edges -( -); - -boundary -( - floor - { - type wall; - faces - ( - (1 5 4 0) - ); - } - ceiling - { - type wall; - faces - ( - (3 7 6 2) - ); - } - fixedWalls - { - type wall; - faces - ( - (0 4 7 3) - (2 6 5 1) - (0 3 2 1) - (4 5 6 7) - ); - } -); - -mergePatchPairs -( -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/thermophysicalProperties b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/thermophysicalProperties deleted file mode 100644 index 55b50fd4b4..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/constant/thermophysicalProperties +++ /dev/null @@ -1,51 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: dev | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "constant"; - object thermophysicalProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -thermoType -{ - type heRhoThermo; - mixture pureMixture; - transport const; - thermo hConst; - energy sensibleEnthalpy; - equationOfState perfectGas; - specie specie; -} - -pRef 100000; - -mixture -{ - specie - { - nMoles 1; - molWeight 28.9; - } - thermodynamics - { - Cp 1000; - Hf 0; - } - transport - { - mu 1.8e-05; - Pr 0.7; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/controlDict b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/controlDict deleted file mode 100644 index 9e12984010..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/controlDict +++ /dev/null @@ -1,49 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: dev | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object controlDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -application buoyantSimpleFoam; - -startFrom latestTime; - -startTime 0; - -stopAt endTime; - -endTime 1000; - -deltaT 1; - -writeControl timeStep; - -writeInterval 100; - -purgeWrite 0; - -writeFormat ascii; - -writePrecision 6; - -writeCompression off; - -timeFormat general; - -timePrecision 6; - -runTimeModifiable true; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSchemes b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSchemes deleted file mode 100644 index 62bdbb235b..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSchemes +++ /dev/null @@ -1,61 +0,0 @@ -/*--------------------------------*- 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 steadyState; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - default none; - div(phi,U) bounded Gauss upwind; - div(phi,h) bounded Gauss upwind; - div(phi,K) bounded Gauss upwind; - div(phi,k) bounded Gauss upwind; - div(phi,epsilon) bounded Gauss upwind; - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear uncorrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default corrected; -} - -fluxRequired -{ - default no; - p_rgh; -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSolution b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSolution deleted file mode 100644 index f7365e5f6d..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/fvSolution +++ /dev/null @@ -1,71 +0,0 @@ -/*--------------------------------*- 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 -{ - p_rgh - { - solver PCG; - preconditioner DIC; - tolerance 1e-8; - relTol 0.01; - } - - "(U|h|e|k|epsilon|R)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-6; - relTol 0.1; - } -} - -SIMPLE -{ - nNonOrthogonalCorrectors 0; - pRefCell 0; - pRefValue 0; - - residualControl - { - p_rgh 1e-2; - U 1e-3; - h 1e-3; - e 1e-3; - - // possibly check turbulence fields - "(k|epsilon|omega)" 1e-3; - } -} - -relaxationFactors -{ - fields - { - rho 1.0; - p_rgh 0.7; - } - equations - { - U 0.3; - "(h|e)" 0.3; - "(k|epsilon|R)" 0.5; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/setFieldsDict b/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/setFieldsDict deleted file mode 100644 index 25eb455679..0000000000 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/system/setFieldsDict +++ /dev/null @@ -1,37 +0,0 @@ -/*--------------------------------*- 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 setFieldsDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -defaultFieldValues -( - volScalarFieldValue T 300 -); - -regions -( - // Set patch values (using ==) - boxToFace - { - box (4.5 -1000 4.5) (5.5 1e-5 5.5); - - fieldValues - ( - volScalarFieldValue T 600 - ); - } -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/T b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/T new file mode 100644 index 0000000000..995ea65f2e --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/T @@ -0,0 +1,77 @@ +/*--------------------------------*- 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/bottomWater"; + object T; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [ 0 0 0 1 0 0 0 ]; + +internalField uniform 300; + +boundaryField +{ + minX + { + type fixedValue; + value uniform 300; + } + maxX + { + type inletOutlet; + value uniform 300; + inletValue uniform 300; + } + minY + { + type zeroGradient; + value uniform 300; + } + minZ + { + type zeroGradient; + value uniform 300; + } + maxZ + { + type zeroGradient; + value uniform 300; + } + bottomWater_to_rightSolid + { + type compressible::turbulentTemperatureCoupledBaffleMixed; + value uniform 300; + Tnbr T; + kappa fluidThermo; + kappaName none; + } + bottomWater_to_leftSolid + { + type compressible::turbulentTemperatureCoupledBaffleMixed; + value uniform 300; + Tnbr T; + kappa fluidThermo; + kappaName none; + } + bottomWater_to_heater + { + type compressible::turbulentTemperatureCoupledBaffleMixed; + value uniform 300; + Tnbr T; + kappa fluidThermo; + kappaName none; + } +} + + +// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/U b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/U similarity index 53% rename from tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/U rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/U index 6c92f22050..4fac313655 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/U +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/U @@ -10,33 +10,59 @@ FoamFile version 2.0; format ascii; class volVectorField; + location "0/bottomWater"; object U; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [0 1 -1 0 0 0 0]; +dimensions [ 0 1 -1 0 0 0 0 ]; -internalField uniform (0 0 0); +internalField uniform ( 0.001 0 0 ); boundaryField { - floor + minX { type fixedValue; - value uniform (0 0 0); + value uniform ( 0.001 0 0 ); } - - ceiling + maxX { - type fixedValue; - value uniform (0 0 0); + type inletOutlet; + value uniform ( 0.01 0 0 ); + inletValue uniform ( 0 0 0 ); } - - fixedWalls + minY { type fixedValue; - value uniform (0 0 0); + value uniform ( 0 0 0 ); + } + minZ + { + type fixedValue; + value uniform ( 0 0 0 ); + } + maxZ + { + type fixedValue; + value uniform ( 0 0 0 ); + } + bottomWater_to_rightSolid + { + type fixedValue; + value uniform ( 0 0 0 ); + } + bottomWater_to_leftSolid + { + type fixedValue; + value uniform ( 0 0 0 ); + } + bottomWater_to_heater + { + type fixedValue; + value uniform ( 0 0 0 ); } } + // ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/mut b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/cellToRegion similarity index 63% rename from tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/mut rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/cellToRegion index 5babd4b607..9b51c7b0f8 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/mut +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/cellToRegion @@ -10,39 +10,50 @@ FoamFile version 2.0; format ascii; class volScalarField; - location "0"; - object mut; + location "0/bottomWater"; + object cellToRegion; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [1 -1 -1 0 0 0 0]; +dimensions [0 0 0 0 0 0 0]; internalField uniform 0; boundaryField { - floor + minX { - type mutkWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; + type zeroGradient; + } + maxX + { + type zeroGradient; + } + minY + { + type zeroGradient; + } + minZ + { + type zeroGradient; + } + maxZ + { + type zeroGradient; + } + bottomWater_to_rightSolid + { + type calculated; value uniform 0; } - ceiling + bottomWater_to_leftSolid { - type mutkWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; + type calculated; value uniform 0; } - fixedWalls + bottomWater_to_heater { - type mutkWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; + type calculated; value uniform 0; } } diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/epsilon b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/epsilon similarity index 62% rename from tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/epsilon rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/epsilon index 2b77f18482..c09d9c59c9 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/epsilon +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/epsilon @@ -10,39 +10,56 @@ FoamFile version 2.0; format ascii; class volScalarField; - location "0"; + location "0/bottomWater"; object epsilon; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [0 2 -3 0 0 0 0]; +dimensions [ 0 2 -3 0 0 0 0 ]; internalField uniform 0.01; boundaryField { - floor + minX { - type compressible::epsilonWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; + type fixedValue; value uniform 0.01; } - ceiling + maxX + { + type inletOutlet; + value uniform 0.01; + inletValue uniform 0.01; + } + minY { type compressible::epsilonWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; value uniform 0.01; } - fixedWalls + minZ + { + type compressible::epsilonWallFunction; + value uniform 0.01; + } + maxZ + { + type compressible::epsilonWallFunction; + value uniform 0.01; + } + bottomWater_to_rightSolid + { + type compressible::epsilonWallFunction; + value uniform 0.01; + } + bottomWater_to_leftSolid + { + type compressible::epsilonWallFunction; + value uniform 0.01; + } + bottomWater_to_heater { type compressible::epsilonWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; value uniform 0.01; } } diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/k b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/k similarity index 62% rename from tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/k rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/k index 62dd722078..556c0d3d9e 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/k +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/k @@ -10,28 +10,54 @@ FoamFile version 2.0; format ascii; class volScalarField; - location "0"; + location "0/bottomWater"; object k; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [0 2 -2 0 0 0 0]; +dimensions [ 0 2 -2 0 0 0 0 ]; internalField uniform 0.1; boundaryField { - floor + minX + { + type inletOutlet; + value uniform 0.1; + inletValue uniform 0.1; + } + maxX + { + type zeroGradient; + value uniform 0.1; + } + minY { type compressible::kqRWallFunction; value uniform 0.1; } - ceiling + minZ { type compressible::kqRWallFunction; value uniform 0.1; } - fixedWalls + maxZ + { + type compressible::kqRWallFunction; + value uniform 0.1; + } + bottomWater_to_rightSolid + { + type compressible::kqRWallFunction; + value uniform 0.1; + } + bottomWater_to_leftSolid + { + type compressible::kqRWallFunction; + value uniform 0.1; + } + bottomWater_to_heater { type compressible::kqRWallFunction; value uniform 0.1; diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/alphat b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/p similarity index 57% rename from tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/alphat rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/p index 881f4c2534..2f81b33af4 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/alphat +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/p @@ -10,33 +10,55 @@ FoamFile version 2.0; format ascii; class volScalarField; - location "0"; - object alphat; + location "0/bottomWater"; + object p; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [1 -1 -1 0 0 0 0]; +dimensions [ 1 -1 -2 0 0 0 0 ]; internalField uniform 0; boundaryField { - floor + minX { - type compressible::alphatWallFunction; - Prt 0.85; + type calculated; value uniform 0; } - ceiling + maxX { - type compressible::alphatWallFunction; - Prt 0.85; + type calculated; value uniform 0; } - fixedWalls + minY { - type compressible::alphatWallFunction; - Prt 0.85; + type calculated; + value uniform 0; + } + minZ + { + type calculated; + value uniform 0; + } + maxZ + { + type calculated; + value uniform 0; + } + bottomWater_to_rightSolid + { + type calculated; + value uniform 0; + } + bottomWater_to_leftSolid + { + type calculated; + value uniform 0; + } + bottomWater_to_heater + { + type calculated; value uniform 0; } } diff --git a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/p_rgh b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/p_rgh similarity index 56% rename from tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/p_rgh rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/p_rgh index 8602946911..9c70303039 100644 --- a/tutorials/heatTransfer/buoyantSimpleFoam/hotRoom/0/p_rgh +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/0/bottomWater/p_rgh @@ -10,33 +10,58 @@ FoamFile version 2.0; format ascii; class volScalarField; + location "0/bottomWater"; object p_rgh; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [1 -1 -2 0 0 0 0]; +dimensions [ 1 -1 -2 0 0 0 0 ]; -internalField uniform 1e5; +internalField uniform 0; boundaryField { - floor + minX { - type fixedFluxPressure; - value uniform 1e5; + type zeroGradient; + value uniform 0; } - - ceiling + maxX { - type fixedFluxPressure; - value uniform 1e5; + type fixedValue; + value uniform 0; } - - fixedWalls + minY { type fixedFluxPressure; - value uniform 1e5; + value uniform 0; + } + minZ + { + type fixedFluxPressure; + value uniform 0; + } + maxZ + { + type fixedFluxPressure; + value uniform 0; + } + bottomWater_to_rightSolid + { + type fixedFluxPressure; + value uniform 0; + } + bottomWater_to_leftSolid + { + type fixedFluxPressure; + value uniform 0; + } + bottomWater_to_heater + { + type fixedFluxPressure; + value uniform 0; } } + // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allclean b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allclean index 01acce5670..e3c17b03fb 100755 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allclean +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allclean @@ -13,7 +13,7 @@ rm -rf 0/heater rm -rf 0/leftSolid rm -rf 0/rightSolid rm -f 0/cellToRegion -rm -rf constant/bottomAir/polyMesh +rm -rf constant/bottomWater/polyMesh rm -rf constant/topAir/polyMesh rm -rf constant/heater/polyMesh rm -rf constant/leftSolid/polyMesh diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun index e86330c489..9bc9be7fec 100755 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/Allrun @@ -16,7 +16,7 @@ do done -for i in bottomAir topAir heater leftSolid rightSolid +for i in bottomWater topAir heater leftSolid rightSolid do changeDictionary -region $i > log.changeDictionary.$i 2>&1 done diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/thermophysicalProperties deleted file mode 100644 index c293c032a3..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/thermophysicalProperties +++ /dev/null @@ -1,49 +0,0 @@ -/*--------------------------------*- 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/bottomAir"; - object thermophysicalProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -thermoType -{ - type heRhoThermo; - mixture pureMixture; - transport const; - thermo hConst; - equationOfState perfectGas; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie - { - nMoles 1; - molWeight 28.9; - } - thermodynamics - { - Cp 1000; - Hf 0; - } - transport - { - mu 1.8e-05; - Pr 0.7; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/RASProperties similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/RASProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/RASProperties diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/g similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/g rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/g diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/radiationProperties similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/radiationProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/radiationProperties diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/thermophysicalProperties similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/thermophysicalProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/thermophysicalProperties diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/turbulenceProperties similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomAir/turbulenceProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/bottomWater/turbulenceProperties diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/radiationProperties index a4e4a923dd..67ab26120b 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/radiationProperties +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/heater/radiationProperties @@ -16,6 +16,8 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +radiation on; + radiationModel opaqueSolid; absorptionEmissionModel constantAbsorptionEmission; @@ -29,5 +31,6 @@ constantAbsorptionEmissionCoeffs scatterModel none; +sootModel none; // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/leftSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/leftSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/leftSolid/radiationProperties new file mode 120000 index 0000000000..08087c37b4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/leftSolid/radiationProperties @@ -0,0 +1 @@ +../heater/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/regionProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/regionProperties index 8e1fe39d2c..0666069c2c 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/regionProperties +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/regionProperties @@ -17,7 +17,7 @@ FoamFile regions ( - fluid (bottomAir topAir) + fluid (bottomWater topAir) solid (heater leftSolid rightSolid) ); diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/rightSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/rightSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/rightSolid/radiationProperties new file mode 120000 index 0000000000..08087c37b4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/rightSolid/radiationProperties @@ -0,0 +1 @@ +../heater/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/RASProperties deleted file mode 100644 index 09a9a55851..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/RASProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel laminar; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/g deleted file mode 100644 index 6f32e33835..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/g +++ /dev/null @@ -1,20 +0,0 @@ -/*--------------------------------*- 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; - object g; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -2 0 0 0 0]; -value (0 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/g new file mode 120000 index 0000000000..fea3757006 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/g @@ -0,0 +1 @@ +../bottomWater/g \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/radiationProperties deleted file mode 100644 index 42defceaf4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/radiationProperties +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- 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 radiationProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -radiation off; - -radiationModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/radiationProperties new file mode 120000 index 0000000000..583b06cb0b --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/radiationProperties @@ -0,0 +1 @@ +../bottomWater/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/thermophysicalProperties index 213e77a87b..c293c032a3 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/thermophysicalProperties +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/thermophysicalProperties @@ -10,7 +10,7 @@ FoamFile version 2.0; format ascii; class dictionary; - location "constant/topAir"; + location "constant/bottomAir"; object thermophysicalProperties; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/turbulenceProperties deleted file mode 100644 index e63bbc5081..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/turbulenceProperties +++ /dev/null @@ -1,19 +0,0 @@ -/*--------------------------------*- 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 turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/turbulenceProperties new file mode 120000 index 0000000000..ec52cbd592 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/constant/topAir/turbulenceProperties @@ -0,0 +1 @@ +../bottomWater/turbulenceProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/makeCellSets.setSet b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/makeCellSets.setSet deleted file mode 100644 index 8f85c9ef23..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/makeCellSets.setSet +++ /dev/null @@ -1,16 +0,0 @@ -cellSet heater new boxToCell (-0.01001 0 -100 )(0.01001 0.00999 100) -cellSet heater add boxToCell (-0.01001 -100 -0.01001)(0.01001 0.00999 0.01001) -cellZoneSet heater new setToCellZone heater -cellSet leftSolid new boxToCell (-100 0 -100 )(-0.01001 0.00999 100) -cellZoneSet leftSolid new setToCellZone leftSolid -cellSet rightSolid new boxToCell (0.01001 0 -100 )(100 0.00999 100) -cellZoneSet rightSolid new setToCellZone rightSolid -cellSet topAir new boxToCell (-100 0.00999 -100 )(100 100 100) -cellZoneSet topAir new setToCellZone topAir -cellSet bottomAir clear -cellSet bottomAir add cellToCell heater -cellSet bottomAir add cellToCell leftSolid -cellSet bottomAir add cellToCell rightSolid -cellSet bottomAir add cellToCell topAir -cellSet bottomAir invert -cellZoneSet bottomAir new setToCellZone bottomAir diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict deleted file mode 100644 index 0f3e91dd5e..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict +++ /dev/null @@ -1,124 +0,0 @@ -/*--------------------------------*- 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 - { - minX - { - type wall; - } - maxX - { - type wall; - } - } - - U - { - internalField uniform (0.01 0 0); - - boundaryField - { - ".*" - { - type fixedValue; - value uniform (0 0 0); - } - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - } - - "bottomAir_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa fluidThermo; - kappaName none; - value uniform 300; - } - } - } - - epsilon - { - internalField uniform 0.01; - - boundaryField - { - ".*" - { - type compressible::epsilonWallFunction; - value uniform 0.01; - } - } - } - - k - { - internalField uniform 0.1; - - boundaryField - { - ".*" - { - type compressible::kqRWallFunction; - value uniform 0.1; - } - } - } - - p_rgh - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type fixedFluxPressure; - value uniform 1e5; - } - } - } - - p - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 1e5; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/decomposeParDict deleted file mode 100644 index b6060f54f0..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/decomposeParDict +++ /dev/null @@ -1,45 +0,0 @@ -/*--------------------------------*- 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 decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -method scotch; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -scotchCoeffs -{ -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSolution deleted file mode 100644 index 7ece4847b8..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSolution +++ /dev/null @@ -1,90 +0,0 @@ -/*--------------------------------*- 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 -{ - rho - { - solver PCG; - preconditioner DIC; - tolerance 1e-6; - relTol 0.1; - } - - rhoFinal - { - $rho; - tolerance 1e-6; - relTol 0; - } - - p_rgh - { - solver GAMG; - tolerance 1e-6; - relTol 0.01; - - smoother GaussSeidel; - - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - maxIter 100; - } - - p_rghFinal - { - $p_rgh; - relTol 0; - } - - "(U|h|k|epsilon|R)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-6; - relTol 0.1; - } - - "(U|h|k|epsilon|R)Final" - { - $U; - tolerance 1e-6; - relTol 0; - } -} - -PIMPLE -{ - momentumPredictor on; - nCorrectors 2; - nNonOrthogonalCorrectors 0; -} - -relaxationFactors -{ - fields - { - } - equations - { - "h.*" 1; - "U.*" 1; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/changeDictionaryDict similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/changeDictionaryDict diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/decomposeParDict similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/decomposeParDict rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/decomposeParDict diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSchemes similarity index 95% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSchemes index 2809fc4f97..3051d55b0f 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSchemes @@ -16,7 +16,7 @@ FoamFile ddtSchemes { - default Euler; + default Euler; } gradSchemes @@ -40,7 +40,7 @@ divSchemes laplacianSchemes { - default Gauss linear corrected; + default Gauss linear corrected; } interpolationSchemes diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSolution similarity index 100% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSolution rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSolution diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/decomposeParDict index 9bdbb31cd2..3eb54ba02f 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/decomposeParDict +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/decomposeParDict @@ -40,18 +40,6 @@ hierarchicalCoeffs order xyz; } -scotchCoeffs -{ - //processorWeights - //( - // 1 - // 1 - // 1 - // 1 - //); - //writeGraph true; - //strategy "b"; -} manualCoeffs { diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvOptions b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvOptions deleted file mode 100644 index 0d85b292af..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvOptions +++ /dev/null @@ -1,73 +0,0 @@ -/*--------------------------------*- 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 fvOptions; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -energySource -{ - type scalarCodedSource; - - active true; - selectionMode all; - - scalarCodedSourceCoeffs - { - fieldNames (h); - redirectType sourceTime; - - codeInclude - #{ - - #}; - - codeCorrect - #{ - //Pout<< "**codeCorrect**" << endl; - #}; - - codeAddSup - #{ - const Time& time = mesh().time(); - const scalarField& V = mesh_.V(); - scalarField& heSource = eqn.source(); - heSource -= 1e4*sqr(time.value())*V; // J/s/m3 - Pout << "heat Source :" << -gSum(heSource) << endl; - #}; - - codeSetValue - #{ - // Pout<< "**codeSetValue**" << endl; - #}; - - // Dummy entry. Make dependent on above to trigger recompilation - code - #{ - $codeCorrect - $codeAddSup - $codeSetValue - #}; - } - - sourceTimeCoeffs - { - // Dummy entry - } - } - - - - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes deleted file mode 100644 index f4d504e5ee..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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(alpha,h) Gauss linear corrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default corrected; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes new file mode 120000 index 0000000000..63236f302c --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes @@ -0,0 +1 @@ +../heater/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution deleted file mode 100644 index ccb0d3183f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution +++ /dev/null @@ -1,40 +0,0 @@ -/*--------------------------------*- 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.1; - } - - hFinal - { - $h; - tolerance 1e-06; - relTol 0; - } -} - -PIMPLE -{ - nNonOrthogonalCorrectors 0; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution new file mode 120000 index 0000000000..0bde0fc62f --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution @@ -0,0 +1 @@ +../heater/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes deleted file mode 100644 index 88d5ad2763..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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(alpha,h) Gauss linear corrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default corrected; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes new file mode 120000 index 0000000000..63236f302c --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSchemes @@ -0,0 +1 @@ +../heater/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution deleted file mode 100644 index ccb0d3183f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution +++ /dev/null @@ -1,40 +0,0 @@ -/*--------------------------------*- 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.1; - } - - hFinal - { - $h; - tolerance 1e-06; - relTol 0; - } -} - -PIMPLE -{ - nNonOrthogonalCorrectors 0; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution new file mode 120000 index 0000000000..0bde0fc62f --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution @@ -0,0 +1 @@ +../heater/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/decomposeParDict index e405fc009e..9bdbb31cd2 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/decomposeParDict +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/decomposeParDict @@ -10,14 +10,22 @@ FoamFile version 2.0; format ascii; class dictionary; + note "mesh decomposition control dictionary"; location "system"; object decomposeParDict; } + // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // numberOfSubdomains 4; +//- Keep owner and neighbour on same processor for faces in zones: +// preserveFaceZones (heater solid1 solid3); + method scotch; +// method hierarchical; +// method simple; +// method manual; simpleCoeffs { @@ -34,6 +42,15 @@ hierarchicalCoeffs scotchCoeffs { + //processorWeights + //( + // 1 + // 1 + // 1 + // 1 + //); + //writeGraph true; + //strategy "b"; } manualCoeffs @@ -41,4 +58,15 @@ manualCoeffs dataFile "decompositionData"; } + +//// Is the case distributed +//distributed yes; +//// Per slave (so nProcs-1 entries) the directory above the case. +//roots +//( +// "/tmp" +// "/tmp" +//); + + // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes deleted file mode 100644 index dca5ba3f8e..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes +++ /dev/null @@ -1,62 +0,0 @@ -/*--------------------------------*- 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; - - div(phi,U) Gauss upwind; - div(phi,K) Gauss linear; - div(phi,h) Gauss upwind; - div(phi,k) Gauss upwind; - div(phi,epsilon) Gauss upwind; - div(phi,R) Gauss upwind; - div(R) Gauss linear; - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear corrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default corrected; -} - -fluxRequired -{ - default no; - p_rgh; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes new file mode 120000 index 0000000000..323c0787e2 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSchemes @@ -0,0 +1 @@ +../bottomWater/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution deleted file mode 100644 index c0d0794aac..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution +++ /dev/null @@ -1,90 +0,0 @@ -/*--------------------------------*- 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 -{ - rho - { - solver PCG; - preconditioner DIC; - tolerance 1e-6; - relTol 0.1; - } - - rhoFinal - { - $rho; - tolerance 1e-6; - relTol 0; - } - - p_rgh - { - solver GAMG; - tolerance 1e-6; - relTol 0.01; - - smoother GaussSeidel; - - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - maxIter 100; - } - - p_rghFinal - { - $p_rgh; - tolerance 1e-6; - relTol 0; - } - - "(U|h|k|epsilon|R)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-6; - relTol 0.1; - } - - "(U|h|k|epsilon|R)Final" - { - $U; - relTol 0; - } -} - -PIMPLE -{ - momentumPredictor on; - nCorrectors 2; - nNonOrthogonalCorrectors 0; -} - -relaxationFactors -{ - fields - { - } - equations - { - "h.*" 1; - "U.*" 1; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution new file mode 120000 index 0000000000..90d9c92347 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution @@ -0,0 +1 @@ +../bottomWater/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topoSetDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topoSetDict index bd14f41a44..8f65cab102 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topoSetDict +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topoSetDict @@ -116,14 +116,14 @@ actions } - // bottomAir is all the other cells + // bottomWater is all the other cells { - name bottomAir; + name bottomWater; type cellZoneSet; action clear; } { - name bottomAir; + name bottomWater; type cellSet; action add; source cellToCell; @@ -133,7 +133,7 @@ actions } } { - name bottomAir; + name bottomWater; type cellSet; action add; source cellToCell; @@ -143,7 +143,7 @@ actions } } { - name bottomAir; + name bottomWater; type cellSet; action add; source cellToCell; @@ -153,7 +153,7 @@ actions } } { - name bottomAir; + name bottomWater; type cellSet; action add; source cellToCell; @@ -163,18 +163,18 @@ actions } } { - name bottomAir; + name bottomWater; type cellSet; action invert; } { - name bottomAir; + name bottomWater; type cellZoneSet; action new; source setToCellZone; sourceInfo { - set bottomAir; + set bottomWater; } } ); diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/T b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/T deleted file mode 100644 index a2e5fd849a..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/T +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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 T; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 1 0 0 0]; - -internalField uniform 300; - -boundaryField -{ - ".*" - { - type calculated; - value uniform 300; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/U b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/U deleted file mode 100644 index 5c6a42bb1d..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/U +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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; - object U; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -1 0 0 0 0]; - -internalField uniform (0.01 0 0); - -boundaryField -{ - ".*" - { - type calculated; - value uniform (0.01 0 0); - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/Ychar b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/Ychar deleted file mode 100644 index 0d9e45f046..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/Ychar +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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 Ychar; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 0 0 0 0]; - -internalField uniform 0.5; - -boundaryField -{ - ".*" - { - type calculated; - value uniform 0.5; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/Ypmma b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/Ypmma deleted file mode 100644 index c2a485aeac..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/Ypmma +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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 Ypmma; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 0 0 0 0]; - -internalField uniform 0.5; - -boundaryField -{ - ".*" - { - type calculated; - value uniform 0.5; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/epsilon b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/epsilon deleted file mode 100644 index e20d661451..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/epsilon +++ /dev/null @@ -1,31 +0,0 @@ -/*--------------------------------*- 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 epsilon; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 2 -3 0 0 0 0]; - -internalField uniform 0.01; - -boundaryField -{ - ".*" - { - type calculated; - value uniform 0.01; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/k b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/k deleted file mode 100644 index 351dfc5606..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/k +++ /dev/null @@ -1,31 +0,0 @@ -/*--------------------------------*- 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 k; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 2 -2 0 0 0 0]; - -internalField uniform 0.1; - -boundaryField -{ - ".*" - { - type calculated; - value uniform 0.1; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/p b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/p deleted file mode 100644 index 3e97215963..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/p +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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 p; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [1 -1 -2 0 0 0 0]; - -internalField uniform 1e5; - -boundaryField -{ - ".*" - { - type calculated; - value uniform 1e5; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/p_rgh b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/p_rgh deleted file mode 100644 index 8673f6e9bc..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/0/p_rgh +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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 p_rgh; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [1 -1 -2 0 0 0 0]; - -internalField uniform 1e5; - -boundaryField -{ - ".*" - { - type calculated; - value uniform 1e5; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/Allclean b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/Allclean deleted file mode 100755 index 88b837a349..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/Allclean +++ /dev/null @@ -1,22 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory - -# Source tutorial clean functions -. $WM_PROJECT_DIR/bin/tools/CleanFunctions - -cleanCase -rm -rf VTK -rm -rf constant/cellToRegion constant/polyMesh/sets -rm -rf 0/bottomWater -rm -rf 0/topAir -rm -rf 0/heater -rm -rf 0/leftSolid -rm -rf 0/rightSolid -rm -f 0/cellToRegion -rm -rf constant/bottomWater/polyMesh -rm -rf constant/topAir/polyMesh -rm -rf constant/heater/polyMesh -rm -rf constant/leftSolid/polyMesh -rm -rf constant/rightSolid/polyMesh - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/Allrun b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/Allrun deleted file mode 100755 index b609b24a30..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/Allrun +++ /dev/null @@ -1,43 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory - - -# Source tutorial run functions -. $WM_PROJECT_DIR/bin/tools/RunFunctions - -runApplication blockMesh -runApplication topoSet -runApplication splitMeshRegions -cellZones -overwrite - -# remove fluid fields from solid regions (important for post-processing) -for i in heater leftSolid rightSolid -do - rm -f 0*/$i/{mut,alphat,epsilon,k,U,p_rgh} -done - - -for i in bottomWater topAir heater leftSolid rightSolid -do - changeDictionary -region $i > log.changeDictionary.$i 2>&1 -done - - -#-- Run on single processor -#runApplication chtMultiRegionFoam - -# Decompose -runApplication decomposePar -allRegions - -# Run -runParallel `getApplication` 4 - -# Reconstruct -runApplication reconstructPar -allRegions - - -echo -echo "creating files for paraview post-processing" -echo -paraFoam -touchAll - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/README.txt b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/README.txt deleted file mode 100644 index 8462b44418..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/README.txt +++ /dev/null @@ -1,16 +0,0 @@ -To run with directional thermo: - -- compile chtMultiRegionFoam/solid/setRegionSolidFields.H with - - tmp tkappa = thermo.directionalK(); - const volSymmTensorField& kappa = tkappa(); - -- change in e.g. heater: - - - in constant/heater/solidThermophysicalProperties: - - thermoType directionalKSolidThermo; - - - in 0/heater/T: - - K directionalSolidThermo; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/RASProperties deleted file mode 100644 index 09a9a55851..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/RASProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel laminar; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/g b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/g deleted file mode 100644 index 6f32e33835..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/g +++ /dev/null @@ -1,20 +0,0 @@ -/*--------------------------------*- 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; - object g; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -2 0 0 0 0]; -value (0 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/radiationProperties deleted file mode 100644 index 42defceaf4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/radiationProperties +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- 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 radiationProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -radiation off; - -radiationModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/turbulenceProperties deleted file mode 100644 index e63bbc5081..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/bottomWater/turbulenceProperties +++ /dev/null @@ -1,19 +0,0 @@ -/*--------------------------------*- 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 turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/heater/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/leftSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/leftSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/leftSolid/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/leftSolid/thermophysicalProperties deleted file mode 120000 index dc4d3a18ee..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/leftSolid/thermophysicalProperties +++ /dev/null @@ -1 +0,0 @@ -../heater/thermophysicalProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/polyMesh/blockMeshDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/polyMesh/blockMeshDict deleted file mode 100644 index 2a69ccd09c..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/polyMesh/blockMeshDict +++ /dev/null @@ -1,96 +0,0 @@ -/*--------------------------------*- 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.1 -0.04 -0.05) - ( 0.1 -0.04 -0.05) - ( 0.1 0.04 -0.05) - (-0.1 0.04 -0.05) - (-0.1 -0.04 0.05) - ( 0.1 -0.04 0.05) - ( 0.1 0.04 0.05) - (-0.1 0.04 0.05) -); - -blocks -( - hex (0 1 2 3 4 5 6 7) (30 10 10) simpleGrading (1 1 1) -); - -edges -( -); - -boundary -( - maxY - { - type wall; - faces - ( - (3 7 6 2) - ); - } - minX - { - type patch; - faces - ( - (0 4 7 3) - ); - } - maxX - { - type patch; - faces - ( - (2 6 5 1) - ); - } - minY - { - type wall; - faces - ( - (1 5 4 0) - ); - } - minZ - { - type wall; - faces - ( - (0 3 2 1) - ); - } - maxZ - { - type wall; - faces - ( - (4 5 6 7) - ); - } -); - -mergePatchPairs -( -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/regionProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/regionProperties deleted file mode 100644 index 59cff17f3f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/regionProperties +++ /dev/null @@ -1,25 +0,0 @@ -/*--------------------------------*- 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 regionProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -regions -( - fluid (bottomWater topAir) - solid (heater leftSolid rightSolid) - -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/rightSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/rightSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/rightSolid/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/rightSolid/thermophysicalProperties deleted file mode 120000 index dc4d3a18ee..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/rightSolid/thermophysicalProperties +++ /dev/null @@ -1 +0,0 @@ -../heater/thermophysicalProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/RASProperties deleted file mode 100644 index 09a9a55851..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/RASProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel laminar; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/g deleted file mode 100644 index 6f32e33835..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/g +++ /dev/null @@ -1,20 +0,0 @@ -/*--------------------------------*- 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; - object g; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -2 0 0 0 0]; -value (0 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/radiationProperties deleted file mode 100644 index 46c72c1aa8..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/radiationProperties +++ /dev/null @@ -1,21 +0,0 @@ -/*--------------------------------*- 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 radiationProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -radiation off; - -radiationModel none; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/thermophysicalProperties deleted file mode 100644 index 213e77a87b..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/thermophysicalProperties +++ /dev/null @@ -1,49 +0,0 @@ -/*--------------------------------*- 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/topAir"; - object thermophysicalProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -thermoType -{ - type heRhoThermo; - mixture pureMixture; - transport const; - thermo hConst; - equationOfState perfectGas; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie - { - nMoles 1; - molWeight 28.9; - } - thermodynamics - { - Cp 1000; - Hf 0; - } - transport - { - mu 1.8e-05; - Pr 0.7; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/turbulenceProperties deleted file mode 100644 index e63bbc5081..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/constant/topAir/turbulenceProperties +++ /dev/null @@ -1,19 +0,0 @@ -/*--------------------------------*- 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 turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/makeCellSets.setSet b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/makeCellSets.setSet deleted file mode 100644 index 7353934fa8..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/makeCellSets.setSet +++ /dev/null @@ -1,16 +0,0 @@ -cellSet heater new boxToCell (-0.01001 0 -100 )(0.01001 0.00999 100) -cellSet heater add boxToCell (-0.01001 -100 -0.01001)(0.01001 0.00999 0.01001) -cellZoneSet heater new setToCellZone heater -cellSet leftSolid new boxToCell (-100 0 -100 )(-0.01001 0.00999 100) -cellZoneSet leftSolid new setToCellZone leftSolid -cellSet rightSolid new boxToCell (0.01001 0 -100 )(100 0.00999 100) -cellZoneSet rightSolid new setToCellZone rightSolid -cellSet topAir new boxToCell (-100 0.00999 -100 )(100 100 100) -cellZoneSet topAir new setToCellZone topAir -cellSet bottomWater clear -cellSet bottomWater add cellToCell heater -cellSet bottomWater add cellToCell leftSolid -cellSet bottomWater add cellToCell rightSolid -cellSet bottomWater add cellToCell topAir -cellSet bottomWater invert -cellZoneSet bottomWater new setToCellZone bottomWater diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict.save b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict.save deleted file mode 100644 index d6817628c6..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/changeDictionaryDict.save +++ /dev/null @@ -1,124 +0,0 @@ -/*--------------------------------*- 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 - { - minX - { - type wall; - } - maxX - { - type wall; - } - } - - U - { - internalField uniform (0.01 0 0); - - boundaryField - { - ".*" - { - type fixedValue; - value uniform (0 0 0); - } - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - } - - "bottomWater_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - neighbourFieldName T; - kappa fluidThermo; - kappaName none; - value uniform 300; - } - } - } - - epsilon - { - internalField uniform 0.01; - - boundaryField - { - ".*" - { - type compressible::epsilonWallFunction; - value uniform 0.01; - } - } - } - - k - { - internalField uniform 0.1; - - boundaryField - { - ".*" - { - type compressible::kqRWallFunction; - value uniform 0.1; - } - } - } - - p_rgh - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type fixedFluxPressure; - value uniform 1e5; - } - } - } - - p - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 1e5; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes deleted file mode 100644 index e08f93840a..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes +++ /dev/null @@ -1,62 +0,0 @@ -/*--------------------------------*- 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; - - div(phi,U) Gauss upwind; - div(phi,K) Gauss linear; - div(phi,h) Gauss upwind; - div(phi,k) Gauss upwind; - div(phi,epsilon) Gauss upwind; - div(phi,R) Gauss upwind; - div(R) Gauss linear; - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; - p_rgh; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/controlDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/controlDict deleted file mode 100644 index 27cb568817..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/controlDict +++ /dev/null @@ -1,55 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: dev | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object controlDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -application chtMultiRegionFoam; - -startFrom latestTime; - -startTime 0.001; - -stopAt endTime; - -endTime 200; - -deltaT 0.001; - -writeControl adjustableRunTime; - -writeInterval 50; - -purgeWrite 0; - -writeFormat binary; - -writePrecision 8; - -writeCompression off; - -timeFormat general; - -timePrecision 6; - -runTimeModifiable yes; - -maxCo 0.3; - -// Maximum diffusion number -maxDi 10.0; - -adjustTimeStep yes; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/decomposeParDict deleted file mode 100644 index 9bdbb31cd2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/decomposeParDict +++ /dev/null @@ -1,72 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -//- Keep owner and neighbour on same processor for faces in zones: -// preserveFaceZones (heater solid1 solid3); - -method scotch; -// method hierarchical; -// method simple; -// method manual; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -scotchCoeffs -{ - //processorWeights - //( - // 1 - // 1 - // 1 - // 1 - //); - //writeGraph true; - //strategy "b"; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -//// Is the case distributed -//distributed yes; -//// Per slave (so nProcs-1 entries) the directory above the case. -//roots -//( -// "/tmp" -// "/tmp" -//); - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/fvSchemes deleted file mode 100644 index e7d321e959..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/fvSchemes +++ /dev/null @@ -1,46 +0,0 @@ -/*--------------------------------*- 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 -{ -} - -gradSchemes -{ -} - -divSchemes -{ -} - -laplacianSchemes -{ -} - -interpolationSchemes -{ -} - -snGradSchemes -{ -} - -fluxRequired -{ -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/fvSolution deleted file mode 100644 index cde9e49189..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/fvSolution +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- 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; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -PIMPLE -{ - nOuterCorrectors 1; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/changeDictionaryDict deleted file mode 100644 index 94194e9fb4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/changeDictionaryDict +++ /dev/null @@ -1,95 +0,0 @@ -/*--------------------------------*- 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 - { - minY - { - type patch; - } - minZ - { - type patch; - } - maxZ - { - type patch; - } - } - - T - { - internalField uniform 300; - - - boundaryField - { - ".*" - { - type zeroGradient; - value uniform 300; - } - "heater_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa solidThermo; - kappaName none; - value uniform 300; - } - minY - { - type fixedValue; - value uniform 500; - } - } - } - - Ypmma - { - internalField uniform 0.5; - - - boundaryField - { - ".*" - { - type calculated; - value uniform 0.5; - } - } - - } - - Ychar - { - internalField uniform 0.5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 0.5; - } - } - } - -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/decomposeParDict deleted file mode 100644 index 9bdbb31cd2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/decomposeParDict +++ /dev/null @@ -1,72 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -//- Keep owner and neighbour on same processor for faces in zones: -// preserveFaceZones (heater solid1 solid3); - -method scotch; -// method hierarchical; -// method simple; -// method manual; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -scotchCoeffs -{ - //processorWeights - //( - // 1 - // 1 - // 1 - // 1 - //); - //writeGraph true; - //strategy "b"; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -//// Is the case distributed -//distributed yes; -//// Per slave (so nProcs-1 entries) the directory above the case. -//roots -//( -// "/tmp" -// "/tmp" -//); - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSchemes deleted file mode 100644 index 998b93b283..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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(alpha,h) Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSolution deleted file mode 100644 index 35018ad1e4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/heater/fvSolution +++ /dev/null @@ -1,39 +0,0 @@ -/*--------------------------------*- 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.1; - } - hFinal - { - $h; - tolerance 1e-06; - relTol 0; - } -} - -PIMPLE -{ - nNonOrthogonalCorrectors 1; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/changeDictionaryDict deleted file mode 100644 index 490a05d4ad..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/changeDictionaryDict +++ /dev/null @@ -1,82 +0,0 @@ -/*--------------------------------*- 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 - { - minZ - { - type patch; - } - maxZ - { - type patch; - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - value uniform 300; - } - "leftSolid_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa solidThermo; - kappaName none; - value uniform 300; - } - } - } - - Ypmma - { - internalField uniform 0.5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 0.5; - } - } - } - - Ychar - { - internalField uniform 0.5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 0.5; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/decomposeParDict deleted file mode 100644 index 9bdbb31cd2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/decomposeParDict +++ /dev/null @@ -1,72 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -//- Keep owner and neighbour on same processor for faces in zones: -// preserveFaceZones (heater solid1 solid3); - -method scotch; -// method hierarchical; -// method simple; -// method manual; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -scotchCoeffs -{ - //processorWeights - //( - // 1 - // 1 - // 1 - // 1 - //); - //writeGraph true; - //strategy "b"; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -//// Is the case distributed -//distributed yes; -//// Per slave (so nProcs-1 entries) the directory above the case. -//roots -//( -// "/tmp" -// "/tmp" -//); - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSchemes deleted file mode 100644 index 998b93b283..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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(alpha,h) Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSolution deleted file mode 120000 index 0bde0fc62f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/leftSolid/fvSolution +++ /dev/null @@ -1 +0,0 @@ -../heater/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/changeDictionaryDict deleted file mode 100644 index 8993bff833..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/changeDictionaryDict +++ /dev/null @@ -1,82 +0,0 @@ -/*--------------------------------*- 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 - { - minZ - { - type patch; - } - maxZ - { - type patch; - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - value uniform 300; - } - "rightSolid_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa solidThermo; - kappaName none; - value uniform 300; - } - } - } - - Ypmma - { - internalField uniform 0.5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 0.5; - } - } - } - - Ychar - { - internalField uniform 0.5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 0.5; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/decomposeParDict deleted file mode 100644 index 9bdbb31cd2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/decomposeParDict +++ /dev/null @@ -1,72 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -//- Keep owner and neighbour on same processor for faces in zones: -// preserveFaceZones (heater solid1 solid3); - -method scotch; -// method hierarchical; -// method simple; -// method manual; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -scotchCoeffs -{ - //processorWeights - //( - // 1 - // 1 - // 1 - // 1 - //); - //writeGraph true; - //strategy "b"; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -//// Is the case distributed -//distributed yes; -//// Per slave (so nProcs-1 entries) the directory above the case. -//roots -//( -// "/tmp" -// "/tmp" -//); - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSchemes deleted file mode 100644 index 998b93b283..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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(alpha,h) Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSolution deleted file mode 120000 index 0bde0fc62f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/rightSolid/fvSolution +++ /dev/null @@ -1 +0,0 @@ -../heater/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/changeDictionaryDict deleted file mode 100644 index 1eb0bd9f86..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/changeDictionaryDict +++ /dev/null @@ -1,172 +0,0 @@ -/*--------------------------------*- 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 -{ - U - { - internalField uniform (0.1 0 0); - - boundaryField - { - ".*" - { - type fixedValue; - value uniform (0 0 0); - } - minX - { - type fixedValue; - value uniform ( 0.1 0 0 ); - } - maxX - { - type inletOutlet; - inletValue uniform ( 0 0 0 ); - value uniform ( 0.1 0 0 ); - } - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - value uniform 300; - } - - minX - { - type fixedValue; - value uniform 300; - } - maxX - { - type inletOutlet; - inletValue uniform 300; - value uniform 300; - } - - "topAir_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa fluidThermo; - kappaName none; - value uniform 300; - } - } - } - - epsilon - { - internalField uniform 0.01; - - boundaryField - { - ".*" - { - type compressible::epsilonWallFunction; - value uniform 0.01; - } - - minX - { - type fixedValue; - value uniform 0.01; - } - maxX - { - type inletOutlet; - inletValue uniform 0.01; - value uniform 0.01; - } - } - } - - k - { - internalField uniform 0.1; - - boundaryField - { - ".*" - { - type compressible::kqRWallFunction; - value uniform 0.1; - } - - minX - { - type fixedValue; - value uniform 0.1; - } - maxX - { - type inletOutlet; - inletValue uniform 0.1; - value uniform 0.1; - } - } - } - - p_rgh - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type fixedFluxPressure; - value uniform 1e5; - } - - maxX - { - type fixedValue; - value uniform 1e5; - } - } - } - - p - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 1e5; - } - - maxX - { - type calculated; - value uniform 1e5; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/decomposeParDict deleted file mode 100644 index 9bdbb31cd2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/decomposeParDict +++ /dev/null @@ -1,72 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -//- Keep owner and neighbour on same processor for faces in zones: -// preserveFaceZones (heater solid1 solid3); - -method scotch; -// method hierarchical; -// method simple; -// method manual; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -scotchCoeffs -{ - //processorWeights - //( - // 1 - // 1 - // 1 - // 1 - //); - //writeGraph true; - //strategy "b"; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -//// Is the case distributed -//distributed yes; -//// Per slave (so nProcs-1 entries) the directory above the case. -//roots -//( -// "/tmp" -// "/tmp" -//); - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSchemes deleted file mode 100644 index 74d5623cb3..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSchemes +++ /dev/null @@ -1,62 +0,0 @@ -/*--------------------------------*- 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; - - div(phi,U) Gauss upwind; - div(phi,K) Gauss linear; - div(phi,h) Gauss upwind; - div(phi,k) Gauss upwind; - div(phi,epsilon) Gauss upwind; - div(phi,R) Gauss upwind; - div(R) Gauss linear; - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; - p_rgh; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSolution deleted file mode 100644 index 7b840f454f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topAir/fvSolution +++ /dev/null @@ -1,92 +0,0 @@ -/*--------------------------------*- 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 -{ - rho - { - solver PCG; - preconditioner DIC; - tolerance 1e-7; - relTol 0.1; - } - - rhoFinal - { - $rho; - tolerance 1e-7; - relTol 0; - } - - p_rgh - { - solver GAMG; - tolerance 1e-7; - relTol 0.01; - - smoother GaussSeidel; - - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - - maxIter 100; - } - - p_rghFinal - { - $p_rgh; - tolerance 1e-7; - relTol 0; - } - - "(U|h|k|epsilon|R)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-7; - relTol 0.1; - } - - "(U|h|k|epsilon|R)Final" - { - $U; - tolerance 1e-7; - relTol 0; - } -} - -PIMPLE -{ - momentumPredictor on; - nCorrectors 2; - nNonOrthogonalCorrectors 0; -} - -relaxationFactors -{ - fields - { - } - equations - { - "h.*" 1; - "U.*" 1; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topoSetDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topoSetDict deleted file mode 100644 index 8f65cab102..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/topoSetDict +++ /dev/null @@ -1,182 +0,0 @@ -/*--------------------------------*- 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 -( - // Heater - { - name heater; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (-0.01001 0 -100 )(0.01001 0.00999 100); - } - } - { - name heater; - type cellSet; - action add; - source boxToCell; - sourceInfo - { - box (-0.01001 -100 -0.01001)(0.01001 0.00999 0.01001); - } - } - { - name heater; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set heater; // name of cellSet - } - } - - // leftSolid - { - name leftSolid; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (-100 0 -100 )(-0.01001 0.00999 100); - } - } - { - name leftSolid; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set leftSolid; - } - } - - // rightSolid - { - name rightSolid; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (0.01001 0 -100 )(100 0.00999 100); - } - } - { - name rightSolid; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set rightSolid; - } - } - - // topAir - { - name topAir; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (-100 0.00999 -100 )(100 100 100); - } - } - { - name topAir; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set topAir; - } - } - - - // bottomWater is all the other cells - { - name bottomWater; - type cellZoneSet; - action clear; - } - { - name bottomWater; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set heater; - } - } - { - name bottomWater; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set leftSolid; - } - } - { - name bottomWater; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set rightSolid; - } - } - { - name bottomWater; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set topAir; - } - } - { - name bottomWater; - type cellSet; - action invert; - } - { - name bottomWater; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set bottomWater; - } - } -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/radiationProperties index a4e4a923dd..ee2e56a39e 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/radiationProperties +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/heater/radiationProperties @@ -16,18 +16,9 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -radiationModel opaqueSolid; +radiation off; -absorptionEmissionModel constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; +radiationModel none; // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/leftSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/leftSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/leftSolid/radiationProperties new file mode 120000 index 0000000000..08087c37b4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/leftSolid/radiationProperties @@ -0,0 +1 @@ +../heater/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/rightSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/rightSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/rightSolid/radiationProperties new file mode 120000 index 0000000000..08087c37b4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/rightSolid/radiationProperties @@ -0,0 +1 @@ +../heater/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties deleted file mode 100644 index 09a9a55851..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel laminar; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties new file mode 120000 index 0000000000..eaf002d2e9 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties @@ -0,0 +1 @@ +../bottomAir/RASProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g deleted file mode 100644 index 6f32e33835..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g +++ /dev/null @@ -1,20 +0,0 @@ -/*--------------------------------*- 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; - object g; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -2 0 0 0 0]; -value (0 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g new file mode 120000 index 0000000000..fe0384ff08 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g @@ -0,0 +1 @@ +../bottomAir/g \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/radiationProperties deleted file mode 100644 index 42defceaf4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/radiationProperties +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- 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 radiationProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -radiation off; - -radiationModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/radiationProperties new file mode 120000 index 0000000000..e8deee4c2f --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/radiationProperties @@ -0,0 +1 @@ +../bottomAir/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties deleted file mode 100644 index 213e77a87b..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties +++ /dev/null @@ -1,49 +0,0 @@ -/*--------------------------------*- 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/topAir"; - object thermophysicalProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -thermoType -{ - type heRhoThermo; - mixture pureMixture; - transport const; - thermo hConst; - equationOfState perfectGas; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie - { - nMoles 1; - molWeight 28.9; - } - thermodynamics - { - Cp 1000; - Hf 0; - } - transport - { - mu 1.8e-05; - Pr 0.7; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties new file mode 120000 index 0000000000..bd35030a13 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties @@ -0,0 +1 @@ +../bottomAir/thermophysicalProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties deleted file mode 100644 index e63bbc5081..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties +++ /dev/null @@ -1,19 +0,0 @@ -/*--------------------------------*- 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 turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties new file mode 120000 index 0000000000..435bf46f77 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties @@ -0,0 +1 @@ +../bottomAir/turbulenceProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/README b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/README deleted file mode 100644 index 5a81b9a570..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/README +++ /dev/null @@ -1,3 +0,0 @@ -fvSolution is used for outer correctors specification. -fvSchemes is only so that pre-processing activities can proceed - diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes index 74d5623cb3..dca5ba3f8e 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes @@ -40,7 +40,7 @@ divSchemes laplacianSchemes { - default Gauss linear limited corrected 0.333; + default Gauss linear corrected; } interpolationSchemes @@ -50,7 +50,7 @@ interpolationSchemes snGradSchemes { - default limited corrected 0.333; + default corrected; } fluxRequired diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes index 998b93b283..8a14cb557a 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes @@ -16,7 +16,7 @@ FoamFile ddtSchemes { - default Euler; + default Euler; } gradSchemes @@ -32,7 +32,7 @@ divSchemes laplacianSchemes { default none; - laplacian(alpha,h) Gauss linear limited corrected 0.333; + laplacian(alpha,h) Gauss linear corrected; } interpolationSchemes @@ -42,7 +42,7 @@ interpolationSchemes snGradSchemes { - default limited corrected 0.333; + default corrected; } fluxRequired diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSolution index ba8e80d5b9..ccb0d3183f 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSolution @@ -34,7 +34,7 @@ solvers PIMPLE { - nNonOrthogonalCorrectors 1; + nNonOrthogonalCorrectors 0; } // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes deleted file mode 100644 index 998b93b283..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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(alpha,h) Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes new file mode 120000 index 0000000000..63236f302c --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes @@ -0,0 +1 @@ +../heater/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes deleted file mode 100644 index 998b93b283..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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(alpha,h) Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes new file mode 120000 index 0000000000..63236f302c --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes @@ -0,0 +1 @@ +../heater/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/snappyHexMeshDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/snappyHexMeshDict index a0510435ba..bafbafc518 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/snappyHexMeshDict +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/snappyHexMeshDict @@ -58,13 +58,6 @@ geometry type triSurfaceMesh; name heater; } - - //refinementBox - //{ - // type searchableBox; - // min (-0.3 -0.4 -0.1); - // max ( 3.0 0.4 1.4); - // } }; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes deleted file mode 100644 index 74d5623cb3..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes +++ /dev/null @@ -1,62 +0,0 @@ -/*--------------------------------*- 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; - - div(phi,U) Gauss upwind; - div(phi,K) Gauss linear; - div(phi,h) Gauss upwind; - div(phi,k) Gauss upwind; - div(phi,epsilon) Gauss upwind; - div(phi,R) Gauss upwind; - div(R) Gauss linear; - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -fluxRequired -{ - default no; - p_rgh; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes new file mode 120000 index 0000000000..ff6aeb82d3 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes @@ -0,0 +1 @@ +../bottomAir/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution deleted file mode 100644 index 72af23d719..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution +++ /dev/null @@ -1,85 +0,0 @@ -/*--------------------------------*- 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 -{ - "(rho|rhoFinal)" - { - solver PCG - preconditioner DIC; - tolerance 1e-7; - relTol 0; - } - - p_rgh - { - solver GAMG; - tolerance 1e-7; - relTol 0.01; - - smoother GaussSeidel; - - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - - maxIter 100; - } - - p_rghFinal - { - $p_rgh; - tolerance 1e-7; - relTol 0; - } - - "(U|h|k|epsilon|R)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-7; - relTol 0.1; - } - - "(U|h|k|epsilon|R)Final" - { - $U; - tolerance 1e-07; - relTol 0; - } -} - -PIMPLE -{ - momentumPredictor on; - nCorrectors 2; - nNonOrthogonalCorrectors 0; -} - -relaxationFactors -{ - fields - { - } - equations - { - "h.*" 1; - "U.*" 1; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution new file mode 120000 index 0000000000..745b2bcfe4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution @@ -0,0 +1 @@ +../bottomAir/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/T b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/T deleted file mode 100644 index 65d05cfc73..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/T +++ /dev/null @@ -1,29 +0,0 @@ -/*--------------------------------*- 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 T; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 1 0 0 0]; - -internalField uniform 300; - -boundaryField -{ - ".*" - { - type calculated; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/U b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/U deleted file mode 100644 index ee97b3a9fd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/U +++ /dev/null @@ -1,29 +0,0 @@ -/*--------------------------------*- 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; - object U; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -1 0 0 0 0]; - -internalField uniform (0.1 0 0); - -boundaryField -{ - ".*" - { - type calculated; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/epsilon b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/epsilon deleted file mode 100644 index d2a81a89e2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/epsilon +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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 epsilon; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 2 -3 0 0 0 0]; - -internalField uniform 0.01; - -boundaryField -{ - ".*" - { - type calculated; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/k b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/k deleted file mode 100644 index ad5c96dfee..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/k +++ /dev/null @@ -1,30 +0,0 @@ -/*--------------------------------*- 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 k; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 2 -2 0 0 0 0]; - -internalField uniform 0.1; - -boundaryField -{ - ".*" - { - type calculated; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/p b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/p deleted file mode 100644 index aaf33c77d4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/p +++ /dev/null @@ -1,29 +0,0 @@ -/*--------------------------------*- 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 p; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [1 -1 -2 0 0 0 0]; - -internalField uniform 1e5; - -boundaryField -{ - ".*" - { - type calculated; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/p_rgh b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/p_rgh deleted file mode 100644 index 0bcd7b7190..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/p_rgh +++ /dev/null @@ -1,29 +0,0 @@ -/*--------------------------------*- 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 p_rgh; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [1 -1 -2 0 0 0 0]; - -internalField uniform 1e5; - -boundaryField -{ - ".*" - { - type calculated; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/Allclean b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/Allclean deleted file mode 100755 index 98a5d09794..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/Allclean +++ /dev/null @@ -1,23 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory - -# Source tutorial clean functions -. $WM_PROJECT_DIR/bin/tools/CleanFunctions - -cleanCase -rm -rf VTK -rm -rf constant/cellToRegion constant/polyMesh/sets -rm -rf 0/bottomAir -rm -rf 0/topAir -rm -rf 0/heater -rm -rf 0/leftSolid -rm -rf 0/rightSolid -rm -f 0/cellToRegion -rm -rf constant/bottomAir/polyMesh -rm -rf constant/topAir/polyMesh -rm -rf constant/heater/polyMesh -rm -rf constant/leftSolid/polyMesh -rm -rf constant/rightSolid/polyMesh -rm -rf postProcessing - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/Allrun b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/Allrun deleted file mode 100755 index a0cd6737ac..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/Allrun +++ /dev/null @@ -1,42 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory - - -# Source tutorial run functions -. $WM_PROJECT_DIR/bin/tools/RunFunctions - -runApplication blockMesh -runApplication topoSet -runApplication splitMeshRegions -cellZones -overwrite - -# remove fluid fields from solid regions (important for post-processing) -for i in heater leftSolid rightSolid -do - rm -f 0*/$i/{mut,alphat,epsilon,k,U,p_rgh} -done - -for i in bottomAir topAir heater leftSolid rightSolid -do - changeDictionary -region $i > log.changeDictionary.$i 2>&1 -done - - -#-- Run on single processor -runApplication `getApplication` - -## Decompose -#runApplication decomposePar -allRegions -# -## Run -#runParallel `getApplication` 4 -# -## Reconstruct -#runApplication reconstructPar -allRegions - - -echo -echo "creating files for paraview post-processing" -echo -paraFoam -touchAll - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/RASProperties deleted file mode 100644 index 09a9a55851..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/RASProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel laminar; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/g b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/g deleted file mode 100644 index 6f32e33835..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/g +++ /dev/null @@ -1,20 +0,0 @@ -/*--------------------------------*- 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; - object g; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -2 0 0 0 0]; -value (0 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/radiationProperties deleted file mode 100644 index 42defceaf4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/radiationProperties +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- 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 radiationProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -radiation off; - -radiationModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/thermophysicalProperties deleted file mode 100644 index c293c032a3..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/thermophysicalProperties +++ /dev/null @@ -1,49 +0,0 @@ -/*--------------------------------*- 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/bottomAir"; - object thermophysicalProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -thermoType -{ - type heRhoThermo; - mixture pureMixture; - transport const; - thermo hConst; - equationOfState perfectGas; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie - { - nMoles 1; - molWeight 28.9; - } - thermodynamics - { - Cp 1000; - Hf 0; - } - transport - { - mu 1.8e-05; - Pr 0.7; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/turbulenceProperties deleted file mode 100644 index e63bbc5081..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/bottomAir/turbulenceProperties +++ /dev/null @@ -1,19 +0,0 @@ -/*--------------------------------*- 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 turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/heater/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/leftSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/leftSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/leftSolid/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/leftSolid/thermophysicalProperties deleted file mode 120000 index dc4d3a18ee..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/leftSolid/thermophysicalProperties +++ /dev/null @@ -1 +0,0 @@ -../heater/thermophysicalProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/polyMesh/blockMeshDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/polyMesh/blockMeshDict deleted file mode 100644 index 2a69ccd09c..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/polyMesh/blockMeshDict +++ /dev/null @@ -1,96 +0,0 @@ -/*--------------------------------*- 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.1 -0.04 -0.05) - ( 0.1 -0.04 -0.05) - ( 0.1 0.04 -0.05) - (-0.1 0.04 -0.05) - (-0.1 -0.04 0.05) - ( 0.1 -0.04 0.05) - ( 0.1 0.04 0.05) - (-0.1 0.04 0.05) -); - -blocks -( - hex (0 1 2 3 4 5 6 7) (30 10 10) simpleGrading (1 1 1) -); - -edges -( -); - -boundary -( - maxY - { - type wall; - faces - ( - (3 7 6 2) - ); - } - minX - { - type patch; - faces - ( - (0 4 7 3) - ); - } - maxX - { - type patch; - faces - ( - (2 6 5 1) - ); - } - minY - { - type wall; - faces - ( - (1 5 4 0) - ); - } - minZ - { - type wall; - faces - ( - (0 3 2 1) - ); - } - maxZ - { - type wall; - faces - ( - (4 5 6 7) - ); - } -); - -mergePatchPairs -( -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/regionProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/regionProperties deleted file mode 100644 index 8e1fe39d2c..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/regionProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 regionProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -regions -( - fluid (bottomAir topAir) - solid (heater leftSolid rightSolid) -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/rightSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/rightSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/rightSolid/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/rightSolid/thermophysicalProperties deleted file mode 120000 index dc4d3a18ee..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/rightSolid/thermophysicalProperties +++ /dev/null @@ -1 +0,0 @@ -../heater/thermophysicalProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/RASProperties deleted file mode 100644 index 09a9a55851..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/RASProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel laminar; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/g deleted file mode 100644 index 6f32e33835..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/g +++ /dev/null @@ -1,20 +0,0 @@ -/*--------------------------------*- 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; - object g; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -2 0 0 0 0]; -value (0 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/radiationProperties deleted file mode 100644 index 42defceaf4..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/radiationProperties +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- 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 radiationProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -radiation off; - -radiationModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/thermophysicalProperties deleted file mode 100644 index 213e77a87b..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/thermophysicalProperties +++ /dev/null @@ -1,49 +0,0 @@ -/*--------------------------------*- 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/topAir"; - object thermophysicalProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -thermoType -{ - type heRhoThermo; - mixture pureMixture; - transport const; - thermo hConst; - equationOfState perfectGas; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie - { - nMoles 1; - molWeight 28.9; - } - thermodynamics - { - Cp 1000; - Hf 0; - } - transport - { - mu 1.8e-05; - Pr 0.7; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/turbulenceProperties deleted file mode 100644 index e63bbc5081..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/constant/topAir/turbulenceProperties +++ /dev/null @@ -1,19 +0,0 @@ -/*--------------------------------*- 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 turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/makeCellSets.setSet b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/makeCellSets.setSet deleted file mode 100644 index 7e0c2bd522..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/makeCellSets.setSet +++ /dev/null @@ -1,16 +0,0 @@ -cellSet heater new boxToCell (-0.01 0 -100 )(0.01 0.01 100) -cellSet heater add boxToCell (-0.01 -100 -0.01)(0.01 0.01 0.01) -cellZoneSet heater new setToCellZone heater -cellSet leftSolid new boxToCell (-100 0 -100 )(-0.01 0.01 100) -cellZoneSet leftSolid new setToCellZone leftSolid -cellSet rightSolid new boxToCell (0.01 0 -100 )(100 0.01 100) -cellZoneSet rightSolid new setToCellZone rightSolid -cellSet topAir new boxToCell (-100 0.01 -100 )(100 100 100) -cellZoneSet topAir new setToCellZone topAir -cellSet bottomAir clear -cellSet bottomAir add cellToCell heater -cellSet bottomAir add cellToCell leftSolid -cellSet bottomAir add cellToCell rightSolid -cellSet bottomAir add cellToCell topAir -cellSet bottomAir invert -cellZoneSet bottomAir new setToCellZone bottomAir diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/README b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/README deleted file mode 100644 index 5a81b9a570..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/README +++ /dev/null @@ -1,3 +0,0 @@ -fvSolution is used for outer correctors specification. -fvSchemes is only so that pre-processing activities can proceed - diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict deleted file mode 100644 index 0f3e91dd5e..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/changeDictionaryDict +++ /dev/null @@ -1,124 +0,0 @@ -/*--------------------------------*- 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 - { - minX - { - type wall; - } - maxX - { - type wall; - } - } - - U - { - internalField uniform (0.01 0 0); - - boundaryField - { - ".*" - { - type fixedValue; - value uniform (0 0 0); - } - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - } - - "bottomAir_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa fluidThermo; - kappaName none; - value uniform 300; - } - } - } - - epsilon - { - internalField uniform 0.01; - - boundaryField - { - ".*" - { - type compressible::epsilonWallFunction; - value uniform 0.01; - } - } - } - - k - { - internalField uniform 0.1; - - boundaryField - { - ".*" - { - type compressible::kqRWallFunction; - value uniform 0.1; - } - } - } - - p_rgh - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type fixedFluxPressure; - value uniform 1e5; - } - } - } - - p - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 1e5; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/decomposeParDict deleted file mode 100644 index 3a9d585cca..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/decomposeParDict +++ /dev/null @@ -1,43 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -method scotch; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSchemes deleted file mode 100644 index c5c1935f60..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSchemes +++ /dev/null @@ -1,63 +0,0 @@ -/*--------------------------------*- 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 steadyState; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - default none; - - div(phi,U) bounded Gauss upwind; - div(phi,K) bounded Gauss upwind; - div(phi,h) bounded Gauss upwind; - div(phi,k) bounded Gauss upwind; - div(phi,K) bounded Gauss upwind; - div(phi,epsilon) bounded Gauss upwind; - div(phi,R) bounded Gauss upwind; - div(R) Gauss linear; - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear uncorrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default uncorrected; -} - -fluxRequired -{ - default no; - p_rgh; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSolution deleted file mode 100644 index 630fd144ab..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/bottomAir/fvSolution +++ /dev/null @@ -1,79 +0,0 @@ -/*--------------------------------*- 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 -{ - rho - { - solver PCG - preconditioner DIC; - tolerance 1e-7; - relTol 0; - } - - p_rgh - { - solver GAMG; - tolerance 1e-7; - relTol 0.01; - - smoother GaussSeidel; - - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - } - - "(U|h|k|epsilon)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-7; - relTol 0.1; - } -} - -SIMPLE -{ - momentumPredictor on; - nNonOrthogonalCorrectors 0; - pRefCell 0; - pRefValue 100000; - rhoMin rhoMin [1 -3 0 0 0] 0.2; - rhoMax rhoMax [1 -3 0 0 0] 2; -} - -relaxationFactors -{ - fields - { - rho 1; - p_rgh 0.7; - } - equations - { - U 0.3; - h 0.7; - nuTilda 0.7; - k 0.7; - epsilon 0.7; - omega 0.7; - "ILambda.*" 0.7; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/controlDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/controlDict deleted file mode 100644 index ce425c2910..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/controlDict +++ /dev/null @@ -1,118 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: dev | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object controlDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -application chtMultiRegionSimpleFoam; - -startFrom startTime; - -startTime 0; - -stopAt endTime; - -endTime 2000; - -deltaT 1; - -writeControl timeStep; - -writeInterval 100; - -purgeWrite 5; - -writeFormat ascii; - -writePrecision 7; - -writeCompression uncompressed; - -timeFormat general; - -timePrecision 6; - -runTimeModifiable true; - -functions -{ - topAir_minX - { - type faceSource; - functionObjectLibs ("libfieldFunctionObjects.so"); - - enabled yes; - outputControl outputTime; - - region topAir; - - // Output to log&file (yes) or to file only - log yes; - - // Output field values as well - valueOutput no; - - // Type of source: patch/faceZone/sampledSurface - source patch; - - // if patch or faceZone: name of patch or faceZone - sourceName minX; - - // Operation: areaAverage/sum/weightedAverage ... - operation areaIntegrate; - - fields - ( - p - phi // surface fields not supported for sampledSurface - U - ); - } - - topAir_maxX - { - type faceSource; - functionObjectLibs ("libfieldFunctionObjects.so"); - - enabled yes; - outputControl outputTime; - - region topAir; - - // Output to log&file (yes) or to file only - log yes; - - // Output field values as well - valueOutput no; - - // Type of source: patch/faceZone/sampledSurface - source patch; - - // if patch or faceZone: name of patch or faceZone - sourceName maxX; - - // Operation: areaAverage/sum/weightedAverage ... - operation areaIntegrate; - - fields - ( - p - phi // surface fields not supported for sampledSurface - U - ); - } - -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/decomposeParDict deleted file mode 100644 index 9bdbb31cd2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/decomposeParDict +++ /dev/null @@ -1,72 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -//- Keep owner and neighbour on same processor for faces in zones: -// preserveFaceZones (heater solid1 solid3); - -method scotch; -// method hierarchical; -// method simple; -// method manual; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -scotchCoeffs -{ - //processorWeights - //( - // 1 - // 1 - // 1 - // 1 - //); - //writeGraph true; - //strategy "b"; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -//// Is the case distributed -//distributed yes; -//// Per slave (so nProcs-1 entries) the directory above the case. -//roots -//( -// "/tmp" -// "/tmp" -//); - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/fvSchemes deleted file mode 100644 index e7d321e959..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/fvSchemes +++ /dev/null @@ -1,46 +0,0 @@ -/*--------------------------------*- 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 -{ -} - -gradSchemes -{ -} - -divSchemes -{ -} - -laplacianSchemes -{ -} - -interpolationSchemes -{ -} - -snGradSchemes -{ -} - -fluxRequired -{ -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/fvSolution deleted file mode 100644 index 007d20b6c3..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/fvSolution +++ /dev/null @@ -1,17 +0,0 @@ -/*--------------------------------*- 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; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/changeDictionaryDict deleted file mode 100644 index 3c883e6ee2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/changeDictionaryDict +++ /dev/null @@ -1,63 +0,0 @@ -/*--------------------------------*- 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 - { - minY - { - type patch; - } - minZ - { - type patch; - } - maxZ - { - type patch; - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - value uniform 300; - } - "heater_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa solidThermo; - kappaName none; - value uniform 300; - } - minY - { - type fixedValue; - value uniform 500; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/decomposeParDict deleted file mode 100644 index 3a9d585cca..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/decomposeParDict +++ /dev/null @@ -1,43 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -method scotch; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSchemes deleted file mode 100644 index eecf556f63..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSchemes +++ /dev/null @@ -1,53 +0,0 @@ -/*--------------------------------*- 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 steadyState; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - default none; -} - -laplacianSchemes -{ - default none; - laplacian(alpha,h) Gauss linear uncorrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default uncorrected; -} - -fluxRequired -{ - default no; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSolution deleted file mode 100644 index f99b4763ee..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/heater/fvSolution +++ /dev/null @@ -1,44 +0,0 @@ -/*--------------------------------*- 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.1; - } -} - -SIMPLE -{ - nNonOrthogonalCorrectors 0; -} - -relaxationFactors -{ - fields - { - } - equations - { - h 0.7; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict deleted file mode 100644 index 987aeb8b43..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict +++ /dev/null @@ -1,54 +0,0 @@ -/*--------------------------------*- 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 - { - minZ - { - type patch; - } - maxZ - { - type patch; - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - value uniform 300; - } - "leftSolid_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa solidThermo; - kappaName none; - value uniform 300; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/decomposeParDict deleted file mode 100644 index f051e7b79a..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/decomposeParDict +++ /dev/null @@ -1,44 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - -method scotch; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSchemes deleted file mode 120000 index 63236f302c..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSchemes +++ /dev/null @@ -1 +0,0 @@ -../heater/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSolution deleted file mode 120000 index 0bde0fc62f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/leftSolid/fvSolution +++ /dev/null @@ -1 +0,0 @@ -../heater/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict deleted file mode 100644 index ba99b13705..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/changeDictionaryDict +++ /dev/null @@ -1,54 +0,0 @@ -/*--------------------------------*- 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 - { - minZ - { - type patch; - } - maxZ - { - type patch; - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - value uniform 300; - } - "rightSolid_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa solidThermo; - kappaName none; - value uniform 300; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/decomposeParDict deleted file mode 100644 index 864b43c359..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/decomposeParDict +++ /dev/null @@ -1,45 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - - -method scotch; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSchemes deleted file mode 120000 index 63236f302c..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSchemes +++ /dev/null @@ -1 +0,0 @@ -../heater/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSolution deleted file mode 120000 index 0bde0fc62f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/rightSolid/fvSolution +++ /dev/null @@ -1 +0,0 @@ -../heater/fvSolution \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/changeDictionaryDict deleted file mode 100644 index fef7666e76..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/changeDictionaryDict +++ /dev/null @@ -1,171 +0,0 @@ -/*--------------------------------*- 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 -{ - U - { - internalField uniform (0.1 0 0); - - boundaryField - { - ".*" - { - type fixedValue; - value uniform (0 0 0); - } - minX - { - type fixedValue; - value uniform ( 0.1 0 0 ); - } - maxX - { - type inletOutlet; - inletValue uniform ( 0 0 0 ); - value uniform ( 0.1 0 0 ); - } - } - } - - T - { - internalField uniform 300; - - boundaryField - { - ".*" - { - type zeroGradient; - } - - minX - { - type fixedValue; - value uniform 300; - } - maxX - { - type inletOutlet; - inletValue uniform 300; - value uniform 300; - } - - "topAir_to_.*" - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa fluidThermo; - kappaName none; - value uniform 300; - } - } - } - - epsilon - { - internalField uniform 0.01; - - boundaryField - { - ".*" - { - type compressible::epsilonWallFunction; - value uniform 0.01; - } - - minX - { - type fixedValue; - value uniform 0.01; - } - maxX - { - type inletOutlet; - inletValue uniform 0.01; - value uniform 0.01; - } - } - } - - k - { - internalField uniform 0.1; - - boundaryField - { - ".*" - { - type compressible::kqRWallFunction; - value uniform 0.1; - } - - minX - { - type fixedValue; - value uniform 0.1; - } - maxX - { - type inletOutlet; - inletValue uniform 0.1; - value uniform 0.1; - } - } - } - - p_rgh - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type fixedFluxPressure; - value uniform 1e5; - } - - maxX - { - type fixedValue; - value uniform 1e5; - } - } - } - - p - { - internalField uniform 1e5; - - boundaryField - { - ".*" - { - type calculated; - value uniform 1e5; - } - - maxX - { - type calculated; - value uniform 1e5; - } - } - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/decomposeParDict deleted file mode 100644 index 864b43c359..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/decomposeParDict +++ /dev/null @@ -1,45 +0,0 @@ -/*--------------------------------*- 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; - note "mesh decomposition control dictionary"; - location "system"; - object decomposeParDict; -} - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -numberOfSubdomains 4; - - -method scotch; - -simpleCoeffs -{ - n (2 2 1); - delta 0.001; -} - -hierarchicalCoeffs -{ - n (2 2 1); - delta 0.001; - order xyz; -} - - -manualCoeffs -{ - dataFile "decompositionData"; -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSchemes deleted file mode 100644 index 8acd8191b2..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSchemes +++ /dev/null @@ -1,63 +0,0 @@ -/*--------------------------------*- 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 steadyState; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - default none; - - div(phi,U) bounded Gauss upwind; - div(phi,K) bounded Gauss upwind; - div(phi,h) bounded Gauss upwind; - div(phi,k) bounded Gauss upwind; - div(phi,K) bounded Gauss upwind; - div(phi,epsilon) bounded Gauss upwind; - div(phi,R) bounded Gauss upwind; - div(R) Gauss linear; - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear uncorrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default uncorrected; -} - -fluxRequired -{ - default no; - p_rgh; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSolution deleted file mode 100644 index 5db08c0bdd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topAir/fvSolution +++ /dev/null @@ -1,81 +0,0 @@ -/*--------------------------------*- 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 -{ - rho - { - solver PCG - preconditioner DIC; - tolerance 1e-7; - relTol 0; - } - - p_rgh - { - solver GAMG; - tolerance 1e-7; - relTol 0.01; - - smoother GaussSeidel; - - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - - maxIter 100; - } - - "(U|h|k|epsilon)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-7; - relTol 0.1; - } -} - -SIMPLE -{ - momentumPredictor on; - nNonOrthogonalCorrectors 0; - pRefCell 0; - pRefValue 100000; - rhoMin rhoMin [1 -3 0 0 0] 0.2; - rhoMax rhoMax [1 -3 0 0 0] 2; -} - -relaxationFactors -{ - fields - { - rho 1; - p_rgh 0.7; - } - equations - { - U 0.3; - h 0.7; - nuTilda 0.7; - k 0.7; - epsilon 0.7; - omega 0.7; - "ILambda.*" 0.7; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topoSetDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topoSetDict deleted file mode 100644 index bd14f41a44..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/system/topoSetDict +++ /dev/null @@ -1,182 +0,0 @@ -/*--------------------------------*- 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 -( - // Heater - { - name heater; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (-0.01001 0 -100 )(0.01001 0.00999 100); - } - } - { - name heater; - type cellSet; - action add; - source boxToCell; - sourceInfo - { - box (-0.01001 -100 -0.01001)(0.01001 0.00999 0.01001); - } - } - { - name heater; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set heater; // name of cellSet - } - } - - // leftSolid - { - name leftSolid; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (-100 0 -100 )(-0.01001 0.00999 100); - } - } - { - name leftSolid; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set leftSolid; - } - } - - // rightSolid - { - name rightSolid; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (0.01001 0 -100 )(100 0.00999 100); - } - } - { - name rightSolid; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set rightSolid; - } - } - - // topAir - { - name topAir; - type cellSet; - action new; - source boxToCell; - sourceInfo - { - box (-100 0.00999 -100 )(100 100 100); - } - } - { - name topAir; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set topAir; - } - } - - - // bottomAir is all the other cells - { - name bottomAir; - type cellZoneSet; - action clear; - } - { - name bottomAir; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set heater; - } - } - { - name bottomAir; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set leftSolid; - } - } - { - name bottomAir; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set rightSolid; - } - } - { - name bottomAir; - type cellSet; - action add; - source cellToCell; - sourceInfo - { - set topAir; - } - } - { - name bottomAir; - type cellSet; - action invert; - } - { - name bottomAir; - type cellZoneSet; - action new; - source setToCellZone; - sourceInfo - { - set bottomAir; - } - } -); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun index ecc9459467..cc0bad0de6 100755 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/Allrun @@ -54,7 +54,7 @@ runApplication `getApplication` #runParallel `getApplication` 4 # ## Reconstruct -#runApplication reconstructPar -allRegions +runApplication reconstructPar -allRegions echo diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/radiationProperties index 4a3082f0e3..504cce231e 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/radiationProperties +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/radiationProperties @@ -15,6 +15,8 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +radiation on; + radiationModel viewFactor; viewFactorCoeffs @@ -33,100 +35,11 @@ constantAbsorptionEmissionCoeffs { absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.01; emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.01; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -greyMeanAbsorptionEmissionCoeffs -{ - lookUpTableFileName "SpeciesTable"; - - EhrrCoeff 0.0; - - CO2 - { - Tcommon 300; //Common Temp - invTemp true; //Is the polynomio using inverse temperature. - Tlow 200; //Low Temp - Thigh 2500; //High Temp - - loTcoeffs //coefss for T < Tcommon - ( - 0 // a0 + - 0 // a1*T + - 0 // a2*T^(+/-)2 + - 0 // a3*T^(+/-)3 + - 0 // a4*T^(+/-)4 + - 0 // a5*T^(+/-)5 + - ); - hiTcoeffs //coefss for T > Tcommon - ( - 18.741 - -121.31e3 - 273.5e6 - -194.05e9 - 56.31e12 - -5.8169e15 - ); - - } - - H2O - { - Tcommon 300; - invTemp true; - Tlow 200; - Thigh 2500; - - loTcoeffs - ( - 0 - 0 - 0 - 0 - 0 - 0 - ); - hiTcoeffs - ( - -0.23093 - -1.12390e3 - 9.4153e6 - -2.99885e9 - 0.51382e12 - -1.868e10 - ); - } - - CH4 - { - Tcommon 300; - Tlow 200; - Thigh 2500; - invTemp false; - - loTcoeffs - ( - 0 - 0 - 0 - 0 - 0 - 0 - ); - hiTcoeffs - ( - 6.6334 - -0.0035686 - 1.6682e-8 - 2.5611e-10 - -2.6558e-14 - 0 - ); - } - + E E [ 1 -1 -3 0 0 0 0 ] 0; } scatterModel none; +sootModel none; // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/viewFactorsDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/viewFactorsDict index 073aa8d6e0..380dcfbeaa 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/viewFactorsDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/bottomAir/viewFactorsDict @@ -16,6 +16,7 @@ FoamFile writeViewFactorMatrix true; writeFacesAgglomeration true; +writePatchViewFactors false; bottomAir_to_heater { diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/radiationProperties index a4e4a923dd..2512362226 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/radiationProperties +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/heater/radiationProperties @@ -16,6 +16,8 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +radiation on; + radiationModel opaqueSolid; absorptionEmissionModel constantAbsorptionEmission; @@ -29,5 +31,6 @@ constantAbsorptionEmissionCoeffs scatterModel none; +sootModel none; // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/leftSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/leftSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/leftSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/leftSolid/radiationProperties new file mode 120000 index 0000000000..08087c37b4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/leftSolid/radiationProperties @@ -0,0 +1 @@ +../heater/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/rightSolid/radiationProperties deleted file mode 100644 index a4e4a923dd..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/rightSolid/radiationProperties +++ /dev/null @@ -1,33 +0,0 @@ -/*--------------------------------*- 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 constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.0; //opaque - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.1; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/rightSolid/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/rightSolid/radiationProperties new file mode 120000 index 0000000000..08087c37b4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/rightSolid/radiationProperties @@ -0,0 +1 @@ +../heater/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/RASProperties deleted file mode 100644 index 09a9a55851..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/RASProperties +++ /dev/null @@ -1,24 +0,0 @@ -/*--------------------------------*- 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 RASProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -RASModel laminar; - -turbulence on; - -printCoeffs on; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/RASProperties new file mode 120000 index 0000000000..eaf002d2e9 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/RASProperties @@ -0,0 +1 @@ +../bottomAir/RASProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/g deleted file mode 100644 index 6f32e33835..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/g +++ /dev/null @@ -1,20 +0,0 @@ -/*--------------------------------*- 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; - object g; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -2 0 0 0 0]; -value (0 -9.81 0); - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/g new file mode 120000 index 0000000000..fe0384ff08 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/g @@ -0,0 +1 @@ +../bottomAir/g \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/radiationProperties deleted file mode 100644 index 00dc289027..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/radiationProperties +++ /dev/null @@ -1,131 +0,0 @@ -/*--------------------------------*- 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 radiationProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -radiationModel viewFactor; - -viewFactorCoeffs -{ - smoothing true; //Smooth view factor matrix (use when in a close surface - //to force Sum(Fij = 1) - constantEmissivity true; //constant emissivity on surfaces. -} - -// Number of flow iterations per radiation iteration -solverFreq 3; - -absorptionEmissionModel constantAbsorptionEmission; - -constantAbsorptionEmissionCoeffs -{ - absorptivity absorptivity [ 0 -1 0 0 0 0 0 ] 0.01; - emissivity emissivity [ 0 -1 0 0 0 0 0 ] 0.01; - E E [ 1 -1 -3 0 0 0 0 ] 0; -} - -greyMeanAbsorptionEmissionCoeffs -{ - lookUpTableFileName "SpeciesTable"; - - EhrrCoeff 0.0; - - CO2 - { - Tcommon 300; //Common Temp - invTemp true; //Is the polynomio using inverse temperature. - Tlow 200; //Low Temp - Thigh 2500; //High Temp - - loTcoeffs //coefss for T < Tcommon - ( - 0 // a0 + - 0 // a1*T + - 0 // a2*T^(+/-)2 + - 0 // a3*T^(+/-)3 + - 0 // a4*T^(+/-)4 + - 0 // a5*T^(+/-)5 + - ); - hiTcoeffs //coefss for T > Tcommon - ( - 18.741 - -121.31e3 - 273.5e6 - -194.05e9 - 56.31e12 - -5.8169e15 - ); - - } - - H2O - { - Tcommon 300; - invTemp true; - Tlow 200; - Thigh 2500; - - loTcoeffs - ( - 0 - 0 - 0 - 0 - 0 - 0 - ); - hiTcoeffs - ( - -0.23093 - -1.12390e3 - 9.4153e6 - -2.99885e9 - 0.51382e12 - -1.868e10 - ); - } - - CH4 - { - Tcommon 300; - Tlow 200; - Thigh 2500; - invTemp false; - - loTcoeffs - ( - 0 - 0 - 0 - 0 - 0 - 0 - ); - hiTcoeffs - ( - 6.6334 - -0.0035686 - 1.6682e-8 - 2.5611e-10 - -2.6558e-14 - 0 - ); - } - -} - -scatterModel none; - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/radiationProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/radiationProperties new file mode 120000 index 0000000000..e8deee4c2f --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/radiationProperties @@ -0,0 +1 @@ +../bottomAir/radiationProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/thermophysicalProperties deleted file mode 100644 index 213e77a87b..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/thermophysicalProperties +++ /dev/null @@ -1,49 +0,0 @@ -/*--------------------------------*- 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/topAir"; - object thermophysicalProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -thermoType -{ - type heRhoThermo; - mixture pureMixture; - transport const; - thermo hConst; - equationOfState perfectGas; - specie specie; - energy sensibleEnthalpy; -} - -mixture -{ - specie - { - nMoles 1; - molWeight 28.9; - } - thermodynamics - { - Cp 1000; - Hf 0; - } - transport - { - mu 1.8e-05; - Pr 0.7; - } -} - - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/thermophysicalProperties new file mode 120000 index 0000000000..bd35030a13 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/thermophysicalProperties @@ -0,0 +1 @@ +../bottomAir/thermophysicalProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/turbulenceProperties deleted file mode 100644 index e63bbc5081..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/turbulenceProperties +++ /dev/null @@ -1,19 +0,0 @@ -/*--------------------------------*- 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 turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/turbulenceProperties new file mode 120000 index 0000000000..435bf46f77 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/constant/topAir/turbulenceProperties @@ -0,0 +1 @@ +../bottomAir/turbulenceProperties \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/makeCellSets.setSet b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/makeCellSets.setSet deleted file mode 100644 index 7e0c2bd522..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/makeCellSets.setSet +++ /dev/null @@ -1,16 +0,0 @@ -cellSet heater new boxToCell (-0.01 0 -100 )(0.01 0.01 100) -cellSet heater add boxToCell (-0.01 -100 -0.01)(0.01 0.01 0.01) -cellZoneSet heater new setToCellZone heater -cellSet leftSolid new boxToCell (-100 0 -100 )(-0.01 0.01 100) -cellZoneSet leftSolid new setToCellZone leftSolid -cellSet rightSolid new boxToCell (0.01 0 -100 )(100 0.01 100) -cellZoneSet rightSolid new setToCellZone rightSolid -cellSet topAir new boxToCell (-100 0.01 -100 )(100 100 100) -cellZoneSet topAir new setToCellZone topAir -cellSet bottomAir clear -cellSet bottomAir add cellToCell heater -cellSet bottomAir add cellToCell leftSolid -cellSet bottomAir add cellToCell rightSolid -cellSet bottomAir add cellToCell topAir -cellSet bottomAir invert -cellZoneSet bottomAir new setToCellZone bottomAir diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/README b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/README deleted file mode 100644 index 69450ffe3a..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/README +++ /dev/null @@ -1,2 +0,0 @@ -fvSolution is used for outer correctors specification. -fvSchemes is only so that pre-processing activities can proceed diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/decomposeParDict index 864b43c359..fd8f4413c3 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/decomposeParDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/leftSolid/decomposeParDict @@ -42,4 +42,5 @@ manualCoeffs } + // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/decomposeParDict index 864b43c359..fd8f4413c3 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/decomposeParDict +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/rightSolid/decomposeParDict @@ -42,4 +42,5 @@ manualCoeffs } + // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes deleted file mode 100644 index 127c9c965f..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes +++ /dev/null @@ -1,64 +0,0 @@ -/*--------------------------------*- 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 steadyState; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - default none; - - div(phi,U) bounded Gauss upwind; - div(phi,K) bounded Gauss upwind; - div(phi,h) bounded Gauss upwind; - div(phi,k) bounded Gauss upwind; - div(phi,K) bounded Gauss upwind; - div(phi,epsilon) bounded Gauss upwind; - div(phi,R) bounded Gauss upwind; - div(R) Gauss linear; - div(Ji,Ii_h) Gauss linearUpwind grad(U); - div((muEff*dev2(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear uncorrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default uncorrected; -} - -fluxRequired -{ - default no; - p_rgh; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes new file mode 120000 index 0000000000..ff6aeb82d3 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSchemes @@ -0,0 +1 @@ +../bottomAir/fvSchemes \ No newline at end of file diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution deleted file mode 100644 index 98bc0a622b..0000000000 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution +++ /dev/null @@ -1,86 +0,0 @@ -/*--------------------------------*- 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 -{ - rho - { - solver PCG - preconditioner DIC; - tolerance 1e-7; - relTol 0; - } - - p_rgh - { - solver GAMG; - tolerance 1e-7; - relTol 0.01; - - smoother GaussSeidel; - - cacheAgglomeration true; - nCellsInCoarsestLevel 10; - agglomerator faceAreaPair; - mergeLevels 1; - - maxIter 100; - } - - "(U|h|k|epsilon|Ii)" - { - solver PBiCG; - preconditioner DILU; - tolerance 1e-7; - relTol 0.1; - } - - G - { - $p_rgh; - tolerance 1e-05; - relTol 0.1; - } -} - -SIMPLE -{ - momentumPredictor on; - nNonOrthogonalCorrectors 0; - pRefCell 0; - pRefValue 100000; - rhoMin rhoMin [1 -3 0 0 0] 0.2; - rhoMax rhoMax [1 -3 0 0 0] 2; -} - -relaxationFactors -{ - fields - { - rho 1.0; - p_rgh 0.7; - } - equations - { - U 0.3; - h 0.7; - "(k|epsilon|omega)" 0.7; - "ILambda.*" 0.7; - Qr 0.7; - } -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution new file mode 120000 index 0000000000..745b2bcfe4 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution @@ -0,0 +1 @@ +../bottomAir/fvSolution \ No newline at end of file