diff --git a/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolverSolve.C b/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolverSolve.C index 42f141965b567f8c3c254c4fa6c71bd398c038c5..1a547204a741a5006272dfb0fb903662212b0018 100644 --- a/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolverSolve.C +++ b/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolverSolve.C @@ -352,7 +352,11 @@ void Foam::GAMGSolver::Vcycle // Scale coarse-grid correction field // but not on the coarsest level because it evaluates to 1 - if (scaleCorrection_ && leveli < coarsestLevel - 1) + if + ( + scaleCorrection_ + && (interpolateCorrection_ || leveli < coarsestLevel - 1) + ) { scale ( diff --git a/src/Pstream/mpi/UIPread.C b/src/Pstream/mpi/UIPread.C index 6994db9395b9e262b52b510c677c791213ed6886..55b9973ff83955b8db04ba6bd01ad1a40be67ec2 100644 --- a/src/Pstream/mpi/UIPread.C +++ b/src/Pstream/mpi/UIPread.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 @@ -261,7 +261,7 @@ Foam::label Foam::UIPstream::read ( buf, bufSize, - MPI_PACKED, + MPI_BYTE, fromProcNo, tag, PstreamGlobals::MPICommunicators_[communicator], @@ -317,7 +317,7 @@ Foam::label Foam::UIPstream::read ( buf, bufSize, - MPI_PACKED, + MPI_BYTE, fromProcNo, tag, PstreamGlobals::MPICommunicators_[communicator], diff --git a/src/Pstream/mpi/UOPwrite.C b/src/Pstream/mpi/UOPwrite.C index 275c2eca43d8245dd03595d3d0cf826a3a223135..1c27ec1dbf84e2b62e792e67d1258e483cbf8427 100644 --- a/src/Pstream/mpi/UOPwrite.C +++ b/src/Pstream/mpi/UOPwrite.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 @@ -74,7 +74,7 @@ bool Foam::UOPstream::write ( const_cast<char*>(buf), bufSize, - MPI_PACKED, + MPI_BYTE, toProcNo, //procID(toProcNo), tag, PstreamGlobals::MPICommunicators_[communicator] //MPI_COMM_WORLD @@ -94,7 +94,7 @@ bool Foam::UOPstream::write ( const_cast<char*>(buf), bufSize, - MPI_PACKED, + MPI_BYTE, toProcNo, //procID(toProcNo), tag, PstreamGlobals::MPICommunicators_[communicator] //MPI_COMM_WORLD @@ -116,7 +116,7 @@ bool Foam::UOPstream::write ( const_cast<char*>(buf), bufSize, - MPI_PACKED, + MPI_BYTE, toProcNo, //procID(toProcNo), tag, PstreamGlobals::MPICommunicators_[communicator],//MPI_COMM_WORLD, diff --git a/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.C b/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.C index 4fb8d7f212463254c073e922b9f7c901ff9f038f..619ce5f1a34dfe2186a7609d07acad79c26efa6e 100644 --- a/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.C +++ b/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2013 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2014 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -102,9 +102,10 @@ Foam::porosityModels::DarcyForchheimer::DarcyForchheimer D_[zoneI][i].yy() = d.value().y(); D_[zoneI][i].zz() = d.value().z(); - F_[zoneI][i].xx() = f.value().x(); - F_[zoneI][i].yy() = f.value().y(); - F_[zoneI][i].zz() = f.value().z(); + // leading 0.5 is from 1/2*rho + F_[zoneI][i].xx() = 0.5*f.value().x(); + F_[zoneI][i].yy() = 0.5*f.value().y(); + F_[zoneI][i].zz() = 0.5*f.value().z(); } D_[zoneI] = coordSys_.R().transformTensor(D_[zoneI], cells); diff --git a/src/finiteVolume/cfdTools/general/porosityModel/porosityModel/porosityModelList.H b/src/finiteVolume/cfdTools/general/porosityModel/porosityModel/porosityModelList.H index 3d0d015923957f2923eebed5e7625c74acb9bdab..8b79095b0daa60e365d1940bd02855f9192d0e8e 100644 --- a/src/finiteVolume/cfdTools/general/porosityModel/porosityModel/porosityModelList.H +++ b/src/finiteVolume/cfdTools/general/porosityModel/porosityModel/porosityModelList.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2014 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -55,7 +55,7 @@ Ostream& operator<<(Ostream& os, const porosityModelList& models); class porosityModelList : - PtrList<porosityModel> + public PtrList<porosityModel> { private: diff --git a/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.C b/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.C index dd912465a0ca32ed9fba08b4bed8ec9402d63759..1b468f825d1c7af72b13c2315ae21badfde52c40 100644 --- a/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.C +++ b/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.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 @@ -25,8 +25,8 @@ License #include "MGridGenGAMGAgglomeration.H" #include "fvMesh.H" -#include "processorPolyPatch.H" #include "addToRunTimeSelectionTable.H" +#include "processorLduInterface.H" // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // @@ -43,6 +43,121 @@ namespace Foam } +// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * // + +void Foam::MGridGenGAMGAgglomeration::swap +( + const lduInterfacePtrsList& interfaces, + const labelUList& cellValues, + PtrList<labelList>& nbrValues +) const +{ + // Initialise transfer of restrict addressing on the interface + forAll(interfaces, inti) + { + if (interfaces.set(inti)) + { + interfaces[inti].initInternalFieldTransfer + ( + Pstream::nonBlocking, + cellValues + ); + } + } + + if (Pstream::parRun()) + { + Pstream::waitRequests(); + } + + // Get the interface agglomeration + nbrValues.setSize(interfaces.size()); + forAll(interfaces, inti) + { + if (interfaces.set(inti)) + { + nbrValues.set + ( + inti, + new labelList + ( + interfaces[inti].internalFieldTransfer + ( + Pstream::nonBlocking, + cellValues + ) + ) + ); + } + } +} + + +void Foam::MGridGenGAMGAgglomeration::getNbrAgglom +( + const lduAddressing& addr, + const lduInterfacePtrsList& interfaces, + const PtrList<labelList>& nbrGlobalAgglom, + labelList& cellToNbrAgglom +) const +{ + cellToNbrAgglom.setSize(addr.size()); + cellToNbrAgglom = -1; + + forAll(interfaces, inti) + { + if (interfaces.set(inti)) + { + if (isA<processorLduInterface>(interfaces[inti])) + { + const processorLduInterface& pldui = + refCast<const processorLduInterface>(interfaces[inti]); + + if (pldui.myProcNo() > pldui.neighbProcNo()) + { + const labelUList& faceCells = + interfaces[inti].faceCells(); + const labelList& nbrData = nbrGlobalAgglom[inti]; + + forAll(faceCells, i) + { + cellToNbrAgglom[faceCells[i]] = nbrData[i]; + } + } + } + } + } +} + + +void Foam::MGridGenGAMGAgglomeration::detectSharedFaces +( + const lduMesh& mesh, + const labelList& value, + labelHashSet& sharedFaces +) const +{ + const lduAddressing& addr = mesh.lduAddr(); + const labelUList& lower = addr.lowerAddr(); + const labelUList& upper = addr.upperAddr(); + + sharedFaces.clear(); + sharedFaces.resize(addr.lowerAddr().size()/100); + + // Detect any faces inbetween same value + forAll(lower, faceI) + { + label lowerData = value[lower[faceI]]; + label upperData = value[upper[faceI]]; + + if (lowerData != -1 && lowerData == upperData) + { + sharedFaces.insert(faceI); + } + } +} + + // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // Foam::MGridGenGAMGAgglomeration::MGridGenGAMGAgglomeration @@ -58,6 +173,13 @@ Foam::MGridGenGAMGAgglomeration::MGridGenGAMGAgglomeration label minSize(readLabel(controlDict.lookup("minSize"))); label maxSize(readLabel(controlDict.lookup("maxSize"))); + // Number of iterations applied to improve agglomeration consistency across + // processor boundaries + label nProcConsistencyIter + ( + readLabel(controlDict.lookup("nProcConsistencyIter")) + ); + // Start geometric agglomeration from the cell volumes and areas of the mesh scalarField* VPtr = const_cast<scalarField*>(&fvMesh_.cellVolumes()); @@ -87,28 +209,6 @@ Foam::MGridGenGAMGAgglomeration::MGridGenGAMGAgglomeration } } - /* - { - scalarField& magSb = *magSbPtr; - const polyBoundaryMesh& patches = fvMesh_.boundaryMesh(); - - forAll(patches, patchi) - { - const polyPatch& pp = patches[patchi]; - - if (!(Pstream::parRun() && isA<processorPolyPatch>(pp))) - { - const labelUList& faceCells = pp.faceCells(); - const vectorField& pSf = pp.faceAreas(); - forAll(faceCells, pfi) - { - magSb[faceCells[pfi]] += mag(pSf[pfi]); - } - } - } - } - */ - // Agglomerate until the required number of cells in the coarsest level // is reached @@ -129,6 +229,63 @@ Foam::MGridGenGAMGAgglomeration::MGridGenGAMGAgglomeration *magSbPtr ); + // Adjust weights only + for (int i=0; i<nProcConsistencyIter; i++) + { + const lduMesh& mesh = meshLevel(nCreatedLevels); + const lduAddressing& addr = mesh.lduAddr(); + const lduInterfacePtrsList interfaces = mesh.interfaces(); + + const labelField& agglom = finalAgglomPtr(); + + // Global nubmering + const globalIndex globalNumbering(nCoarseCells); + + labelField globalAgglom(addr.size()); + forAll(agglom, cellI) + { + globalAgglom[cellI] = globalNumbering.toGlobal(agglom[cellI]); + } + + // Get the interface agglomeration + PtrList<labelList> nbrGlobalAgglom; + swap(interfaces, globalAgglom, nbrGlobalAgglom); + + + // Get the interface agglomeration on a cell basis (-1 for all + // other cells) + labelList cellToNbrAgglom; + getNbrAgglom(addr, interfaces, nbrGlobalAgglom, cellToNbrAgglom); + + + // Mark all faces inbetween cells with same nbragglomeration + labelHashSet sharedFaces(addr.size()/100); + detectSharedFaces(mesh, cellToNbrAgglom, sharedFaces); + + + //- Note: in-place update of weights is more effective it seems? + // Should not be. fluke? + //scalarField weights(*faceWeightsPtr); + scalarField weights = *magSfPtr; + forAllConstIter(labelHashSet, sharedFaces, iter) + { + label faceI= iter.key(); + weights[faceI] *= 2.0; + } + + // Redo the agglomeration using the new weights + finalAgglomPtr = agglomerate + ( + nCoarseCells, + minSize, + maxSize, + meshLevel(nCreatedLevels).lduAddr(), + *VPtr, + weights, + *magSbPtr + ); + } + if (continueAgglomerating(nCoarseCells)) { nCells_[nCreatedLevels] = nCoarseCells; diff --git a/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.H b/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.H index 5ed8e2a401c11c640a0ceaaccedc755a84f4c3f7..21090e7513c653d0d71bed5c18ad3a1f941e2e03 100644 --- a/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.H +++ b/src/fvAgglomerationMethods/MGridGenGamgAgglomeration/MGridGenGAMGAgglomeration.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 @@ -67,6 +67,29 @@ class MGridGenGAMGAgglomeration // Private Member Functions + void swap + ( + const lduInterfacePtrsList& interfaces, + const labelUList& cellValues, + PtrList<labelList>& nbrValues + ) const; + + void getNbrAgglom + ( + const lduAddressing& addr, + const lduInterfacePtrsList& interfaces, + const PtrList<labelList>& nbrGlobalAgglom, + labelList& cellToNbrAgglom + ) const; + + void detectSharedFaces + ( + const lduMesh& mesh, + const labelList& value, + labelHashSet& sharedFaces + ) const; + + //- Construct the CSR format addressing void makeCompactCellFaceAddressingAndFaceWeights ( diff --git a/src/fvOptions/sources/general/codedSource/CodedSource.C b/src/fvOptions/sources/general/codedSource/CodedSource.C index 80be8bf45f5a265791ffa49b7d1f8abe58002ed6..43e73377e3843d7aee027fde14230111080b92b5 100644 --- a/src/fvOptions/sources/general/codedSource/CodedSource.C +++ b/src/fvOptions/sources/general/codedSource/CodedSource.C @@ -65,14 +65,14 @@ void Foam::fv::CodedSource<Type>::prepare dynCode.setMakeOptions ( "EXE_INC = -g \\\n" - "-I$(LIB_SRC)/fieldSources/lnInclude \\\n" + "-I$(LIB_SRC)/fvOptions/lnInclude \\\n" "-I$(LIB_SRC)/finiteVolume/lnInclude \\\n" "-I$(LIB_SRC)/meshTools/lnInclude \\\n" "-I$(LIB_SRC)/sampling/lnInclude \\\n" + context.options() + "\n\nLIB_LIBS = \\\n" + " -lmeshTools \\\n" - + " -lfieldSources \\\n" + + " -lfvOptions \\\n" + " -lsampling \\\n" + " -lfiniteVolume \\\n" + context.libs() diff --git a/src/fvOptions/sources/general/codedSource/CodedSource.H b/src/fvOptions/sources/general/codedSource/CodedSource.H index e414bc1e02c3289bb05187d025fdf97e0386e02a..9a09f7ca4de9c81e5f3acedf3e19b8f6f4ae8db0 100644 --- a/src/fvOptions/sources/general/codedSource/CodedSource.H +++ b/src/fvOptions/sources/general/codedSource/CodedSource.H @@ -25,44 +25,85 @@ Class Foam::fv::codedSource Description - Constructs on-the-fly source + Constructs on-the-fly fvOption source + + The hook functions take the following arguments: + + codeCorrect + ( + GeometricField<Type, fvPatchField, volMesh>& fld + ) + + codeAddSup + ( + fvMatrix<Type}>& eqn, + const label fieldI + ) + + setValue + ( + fvMatrix<Type}>& eqn, + const label fieldI + ) + + where : + fld is the field in fieldNames + eqn is the fvMatrix \heading Source usage - Example usage: + Example usage in controlDict: \verbatim - vectorCodedSourceCoeffs + energySource { - fieldNames (U); - redirectType ramp; - - codeCorrect - #{ - Pout<< "**codeCorrect**" << endl; - #}; - - codeAddSup - #{ - Pout<< "**codeAddSup**" << endl; - #}; - - codeSetValue - #{ - Pout<< "**codeSetValue**" << endl; - #}; - - // Dummy entry. Make dependent on above to trigger recompilation - code - #{ - $codeCorrect - $codeAddSup - $codeSetValue - #}; + 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 -= 0.1*sqr(time.value())*V; + #}; + + codeSetValue + #{ + Pout<< "**codeSetValue**" << endl; + #}; + + // Dummy entry. Make dependent on above to trigger recompilation + code + #{ + $codeInclude + $codeCorrect + $codeAddSup + $codeSetValue + #}; + } + + sourceTimeCoeffs + { + // Dummy entry + } } - - // Dummy entry - rampCoeffs - {} \endverbatim diff --git a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.H index 67788bd3c70018ec678b124686ecf4cc4ddbaf06..bbe654639d7deb55b6a526ca0a1baff1c37bfa61 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 75166563506e6d2e6cc0f6acb4ccdfbd9ba6e88c..1cfeeb7488afb54ca3c20381d5620bde9b1fe4f4 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; - - // Thermo baffle model - regionName baffleRegion; // solid region name - infoOutput yes; - active yes; + 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; + + // Baffle region name + regionName baffleRegion; + active yes; // Solid thermo in solid region - thermoType + thermoType + { + type heSolidThermo; + mixture pureMixture; + transport constIso; + thermo hConst; + equationOfState rhoConst; + specie specie; + energy sensibleEnthalpy; + } + + mixture + { + specie { - type heSolidThermo; - mixture pureSolidMixture; - transport constIso; - thermo hConst; - equationOfState rhoConst; - specie specie; - energy sensibleEnthalpy; + nMoles 1; + molWeight 20; } - - mixture + transport { - specie - { - nMoles 1; - molWeight 20; - } - transport - { - kappa 0.01; - } - thermodynamics - { - Hf 0; - Cp 15; - } - density - { - rho 80; - } + kappa 0.01; } - - radiation + thermodynamics + { + Hf 0; + Cp 15; + } + density { - radiationModel opaqueSolid; - absorptionEmissionModel none; - scatterModel none; + rho 80; } + } + + 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; + } + } + \endverbatim - // New mesh polyPatch information + /- Slave patch on primary region + \verbatim + myPatch_slave + { + type compressible::thermalBaffle; + kappa fluidThermo; + kappaName none; + value uniform 300; + \endverbatim - 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); - } + /- Patches on baffle region + \verbatim + bottom + { + type compressible::thermalBaffle; + kappa solidThermo; + kappaName none; + value uniform 300; + } - sideCoeffs - { - name "side"; - type patch; - } + 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 66cdfb99adcf29fec7e4167798d60388c0cb5100..11eb29a28dec13c07e1616ae0859480e3e788b1a 100644 --- a/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.C +++ b/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.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 @@ -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 001a7839e79d68f0bf6c45e59e1b55bd4867322d..f3307daef7806ceebff61f00824eecc2892457f7 100644 --- a/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.H +++ b/src/thermophysicalModels/radiationModels/radiationModel/radiationModel/radiationModel.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 @@ -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<scatterModel> scatter_; + //- Soot model + autoPtr<sootModel> 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 7a9f0f1d7efa66ab7b0b83650f642bba457b8ec4..bed019f4bd2bdd38d1e574e07ae7a01d761f89e8 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 ef835546edc8b5b4aba9ca1fb90a6aad0cd797ad..f71810b2d5051ceeca298d44fb8743aa2a0f27a0 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<mappedPatchBase>(this->patch().patch())) { @@ -101,6 +110,24 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField << exit(FatalError); } + if (dict.found("thicknessLayers")) + { + dict.lookup("thicknessLayers") >> thicknessLayers_; + dict.lookup("kappaLayers") >> kappaLayers_; + + if (thicknessLayers_.size() > 0) + { + forAll (thicknessLayers_, iLayer) + { + const scalar l = thicknessLayers_[iLayer]; + if (l > 0.0) + { + contactRes_ += kappaLayers_[iLayer]/l; + } + } + } + } + fvPatchScalarField::operator=(scalarField("value", dict, p.size())); if (dict.found("refValue")) @@ -129,7 +156,10 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField : mixedFvPatchScalarField(wtcsf, iF), temperatureCoupledBase(patch(), wtcsf.KMethod(), wtcsf.kappaName()), - TnbrName_(wtcsf.TnbrName_) + TnbrName_(wtcsf.TnbrName_), + thicknessLayers_(wtcsf.thicknessLayers_), + kappaLayers_(wtcsf.kappaLayers_), + contactRes_(wtcsf.contactRes_) {} @@ -155,7 +185,7 @@ void turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::updateCoeffs() const fvPatch& nbrPatch = refCast<const fvMesh>(nbrMesh).boundary()[samplePatchI]; - tmp<scalarField> intFld = patchInternalField(); + //tmp<scalarField> intFld = patchInternalField(); // Calculate the temperature by harmonic averaging @@ -174,12 +204,22 @@ void turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::updateCoeffs() ); // Swap to obtain full local values of neighbour internal field - scalarField nbrIntFld(nbrField.patchInternalField()); - mpp.distribute(nbrIntFld); + tmp<scalarField> nbrIntFld(new scalarField(nbrField.size(), 0.0)); + tmp<scalarField> nbrKDelta(new scalarField(nbrField.size(), 0.0)); + + if (contactRes_ == 0.0) + { + nbrIntFld() = nbrField.patchInternalField(); + nbrKDelta() = nbrField.kappa(nbrField)*nbrPatch.deltaCoeffs(); + } + else + { + nbrIntFld() = nbrField; + nbrKDelta() = contactRes_; + } - // Swap to obtain full local values of neighbour kappa*delta - scalarField nbrKDelta(nbrField.kappa(nbrField)*nbrPatch.deltaCoeffs()); - mpp.distribute(nbrKDelta); + mpp.distribute(nbrIntFld()); + mpp.distribute(nbrKDelta()); tmp<scalarField> myKDelta = kappa(*this)*patch().deltaCoeffs(); @@ -200,11 +240,11 @@ void turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::updateCoeffs() // - mixFraction = nbrKDelta / (nbrKDelta + myKDelta()) - this->refValue() = nbrIntFld; + this->refValue() = nbrIntFld(); this->refGrad() = 0.0; - this->valueFraction() = nbrKDelta/(nbrKDelta + myKDelta()); + this->valueFraction() = nbrKDelta()/(nbrKDelta() + myKDelta()); mixedFvPatchScalarField::updateCoeffs(); @@ -239,6 +279,9 @@ void turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::write mixedFvPatchScalarField::write(os); os.writeKeyword("Tnbr")<< TnbrName_ << token::END_STATEMENT << nl; + thicknessLayers_.writeEntry("thicknessLayers", os); + thicknessLayers_.writeEntry("kappaLayers", os); + temperatureCoupledBase::write(os); } diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.H index 0484337b9a8d09e2c8f52a80562f0d70a2d34e12..ad4bc066b2b6809b301cd155077f966ef898b235 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.H +++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.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 @@ -22,11 +22,20 @@ License along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>. Class - Foam::compressible::turbulentTemperatureCoupledBaffleMixedFvPatchScalarField + Foam:: + compressible:: + turbulentTemperatureCoupledBaffleMixedFvPatchScalarField Description Mixed boundary condition for temperature, to be used for heat-transfer - on back-to-back baffles. + on back-to-back baffles.Optional thin thermal layer + resistances can be specified through thicknessLayers and kappaLayers + entries. + + The thermal conductivity, \c kappa, can either be retrieved from the + mesh database using the \c lookup option, or from a \c solidThermo + or \c fluidThermo thermophysical package. + Specifies gradient and temperature such that the equations are the same on both sides: @@ -36,29 +45,41 @@ Description where KDelta is heat-transfer coefficient K * deltaCoeffs - Example usage: - myInterfacePatchName - { - type compressible::turbulentTemperatureCoupledBaffleMixed; - Tnbr T; - kappa lookup; - kappaName kappa; - value uniform 300; - } + \heading Patch usage + + \table + Property | Description | Required | Default value + kappa | thermal conductivity option | yes | + kappaName | name of thermal conductivity field | no | + Tnbr | name of the field | no | T + thicknessLayers | list of thicknesses per layer [m] | no | + kappaLayers | list of thermal conductivites per layer [W/m/K] | no | + \endtable + + Example of the boundary condition specification: + \verbatim + myPatch + { + type compressible::turbulentTemperatureCoupledBaffleMixed; + Tnbr T; + kappa lookup; + KappaName kappa; + thicknessLayers (0.1 0.2 0.3 0.4); + kappaLayers (1 2 3 4) + value uniform 300; + } Needs to be on underlying mapped(Wall)FvPatch. Note: kappa : heat conduction at patch. Gets supplied how to lookup calculate kappa: + - 'lookup' : lookup volScalarField (or volSymmTensorField) with name - 'fluidThermo' : use fluidThermo and compressible::RASmodel to calculate kappa - 'solidThermo' : use solidThermo kappa() - 'directionalSolidThermo' directionalKappa() - Note: runs in parallel with arbitrary decomposition. Uses mapped - functionality to calculate exchange. - SourceFiles turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C @@ -69,6 +90,7 @@ SourceFiles #include "mixedFvPatchFields.H" #include "temperatureCoupledBase.H" +#include "scalarField.H" // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -91,6 +113,15 @@ class turbulentTemperatureCoupledBaffleMixedFvPatchScalarField //- Name of field on the neighbour region const word TnbrName_; + //- Thickness of layers + scalarList thicknessLayers_; + + //- Conductivity of layers + scalarList kappaLayers_; + + //- Total contact resistance + scalar contactRes_; + public: diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C index 6d512d50bd5c6479c42832e16ccfa8b131efe83c..2e6831870ad4dd41678c9882850237b533744cac 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 @@ -49,7 +49,10 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField temperatureCoupledBase(patch(), "undefined", "undefined-K"), TnbrName_("undefined-Tnbr"), QrNbrName_("undefined-QrNbr"), - QrName_("undefined-Qr") + QrName_("undefined-Qr"), + thicknessLayers_(0), + kappaLayers_(0), + contactRes_(0) { this->refValue() = 0.0; this->refGrad() = 0.0; @@ -70,7 +73,10 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField temperatureCoupledBase(patch(), psf.KMethod(), psf.kappaName()), TnbrName_(psf.TnbrName_), QrNbrName_(psf.QrNbrName_), - QrName_(psf.QrName_) + QrName_(psf.QrName_), + thicknessLayers_(psf.thicknessLayers_), + kappaLayers_(psf.kappaLayers_), + contactRes_(psf.contactRes_) {} @@ -86,7 +92,10 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField temperatureCoupledBase(patch(), dict), TnbrName_(dict.lookupOrDefault<word>("Tnbr", "T")), QrNbrName_(dict.lookupOrDefault<word>("QrNbr", "none")), - QrName_(dict.lookupOrDefault<word>("Qr", "none")) + QrName_(dict.lookupOrDefault<word>("Qr", "none")), + thicknessLayers_(0), + kappaLayers_(0), + contactRes_(0.0) { if (!isA<mappedPatchBase>(this->patch().patch())) { @@ -107,6 +116,24 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField << exit(FatalError); } + if (dict.found("thicknessLayers")) + { + dict.lookup("thicknessLayers") >> thicknessLayers_; + dict.lookup("kappaLayers") >> kappaLayers_; + + if (thicknessLayers_.size() > 0) + { + forAll (thicknessLayers_, iLayer) + { + const scalar l = thicknessLayers_[iLayer]; + if (l > 0.0) + { + contactRes_ += kappaLayers_[iLayer]/l; + } + } + } + } + fvPatchScalarField::operator=(scalarField("value", dict, p.size())); if (dict.found("refValue")) @@ -137,7 +164,10 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField temperatureCoupledBase(patch(), psf.KMethod(), psf.kappaName()), TnbrName_(psf.TnbrName_), QrNbrName_(psf.QrNbrName_), - QrName_(psf.QrName_) + QrName_(psf.QrName_), + thicknessLayers_(psf.thicknessLayers_), + kappaLayers_(psf.kappaLayers_), + contactRes_(psf.contactRes_) {} @@ -180,9 +210,17 @@ void turbulentTemperatureRadCoupledMixedFvPatchScalarField::updateCoeffs() // Swap to obtain full local values of neighbour K*delta - scalarField KDeltaNbr(nbrField.kappa(nbrField)*nbrPatch.deltaCoeffs()); - mpp.distribute(KDeltaNbr); - + tmp<scalarField> KDeltaNbr(new scalarField(TcNbr.size(), 0.0)); + if (contactRes_ == 0.0) + { + // Swap to obtain full local values of neighbour K*delta + KDeltaNbr() = nbrField.kappa(nbrField)*nbrPatch.deltaCoeffs(); + } + else + { + KDeltaNbr() = contactRes_; + } + mpp.distribute(KDeltaNbr()); scalarField KDelta(kappa(*this)*patch().deltaCoeffs()); @@ -199,16 +237,34 @@ void turbulentTemperatureRadCoupledMixedFvPatchScalarField::updateCoeffs() mpp.distribute(QrNbr); } - scalarField alpha(KDeltaNbr - (Qr + QrNbr)/Tp); + scalarField alpha(KDeltaNbr() - (Qr + QrNbr)/Tp); valueFraction() = alpha/(alpha + KDelta); - refValue() = (KDeltaNbr*TcNbr)/alpha; + refValue() = (KDeltaNbr()*TcNbr)/alpha; + + mixedFvPatchScalarField::updateCoeffs(); + + if (debug) + { + scalar Q = gSum(kappa(*this)*patch().magSf()*snGrad()); + + Info<< patch().boundaryMesh().mesh().name() << ':' + << patch().name() << ':' + << this->dimensionedInternalField().name() << " <- " + << nbrMesh.name() << ':' + << nbrPatch.name() << ':' + << this->dimensionedInternalField().name() << " :" + << " heat transfer rate:" << Q + << " walltemperature " + << " min:" << gMin(*this) + << " max:" << gMax(*this) + << " avg:" << gAverage(*this) + << endl; + } // Restore tag UPstream::msgType() = oldTag; - - mixedFvPatchScalarField::updateCoeffs(); } @@ -221,6 +277,10 @@ void turbulentTemperatureRadCoupledMixedFvPatchScalarField::write os.writeKeyword("Tnbr")<< TnbrName_ << token::END_STATEMENT << nl; os.writeKeyword("QrNbr")<< QrNbrName_ << token::END_STATEMENT << nl; os.writeKeyword("Qr")<< QrName_ << token::END_STATEMENT << nl; + os.writeKeyword("Qr")<< QrName_ << token::END_STATEMENT << nl; + thicknessLayers_.writeEntry("thicknessLayers", os); + thicknessLayers_.writeEntry("kappaLayers", os); + temperatureCoupledBase::write(os); } diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H index 3d4b80085a1eab3b82b9d5df1fb0603cbd97e4cb..47d7e58f7904b8ceb2f0b99b7656a147009c47f9 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.H +++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.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 @@ -28,23 +28,45 @@ Class Description Mixed boundary condition for temperature and radiation heat transfer - to be used for in multiregion cases - - Example usage: - myInterfacePatchName - { - type compressible::turbulentTemperatureRadCoupledMixed; - Tnbr T; // name of T field on neighbour region - kappa lookup; - KappaName kappa; - QrNbr Qr; // or none. Name of Qr field on neighbour region - Qr Qr; // or none. Name of Qr field on local region - value uniform 300; - } + to be used for in multiregion cases. Optional thin thermal layer + resistances can be specified through thicknessLayers and kappaLayers + entries. + + The thermal conductivity, \c kappa, can either be retrieved from the + mesh database using the \c lookup option, or from a \c solidThermo + or \c fluidThermo thermophysical package. + + \heading Patch usage + + \table + Property | Description | Required | Default value + kappa | thermal conductivity option | yes | + kappaName | name of thermal conductivity field | no | + Tnbr | name of the field | no | T + QrNbr | name of the radiative flux in the nbr region | no | none + Qr | name of the radiative flux in this region | no | none + thicknessLayers | list of thicknesses per layer [m] | no | + kappaLayers | list of thermal conductivites per layer [W/m/K] | no | + \endtable + + Example of the boundary condition specification: + \verbatim + myPatch + { + type compressible::turbulentTemperatureRadCoupledMixed; + Tnbr T; + kappa lookup; + KappaName kappa; + QrNbr Qr; // or none. Name of Qr field on neighbour region + Qr Qr; // or none. Name of Qr field on local region + thicknessLayers (0.1 0.2 0.3 0.4); + kappaLayers (1 2 3 4) + value uniform 300; + } Needs to be on underlying mapped(Wall)FvPatch. - Note: kappa : heat conduction at patch. Gets supplied how to + Note: kappa : heat conduction at patch. Gets supplied how to lookup/calculate kappa: - 'lookup' : lookup volScalarField (or volSymmTensorField) with name @@ -52,9 +74,6 @@ Description - 'solidThermo' : use solidThermo kappa() - 'directionalSolidThermo' directionalKappa() - Note: runs in parallel with arbitrary decomposition. Uses mapped - functionality to calculate exchange. - SourceFiles turbulentTemperatureRadCoupledMixedFvPatchScalarField.C @@ -65,6 +84,7 @@ SourceFiles #include "mixedFvPatchFields.H" #include "temperatureCoupledBase.H" +#include "scalarList.H" // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -93,6 +113,15 @@ class turbulentTemperatureRadCoupledMixedFvPatchScalarField //- Name of the radiative heat flux in local region const word QrName_; + //- Thickness of layers + scalarList thicknessLayers_; + + //- Conductivity of layers + scalarList kappaLayers_; + + //- Total contact resistance + scalar contactRes_; + public: diff --git a/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/radiationProperties b/tutorials/combustion/fireFoam/les/oppositeBurningPanels/constant/panelRegion/radiationProperties index 18b20332bbff09b376f7e2c8465a734a0f39c57f..71abc0f0fad385895ba84af4c11806b301831627 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 7345991f719934ed54e9b6a34755aa9a6b6722ac..a95844ff600d9c1263b748e7746360aa2f0e2d41 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 7ba1c2cc9d3e61f12a630003a6a8c55beaa363b2..405227e503168ab394db8e5448ce67cd42f955cc 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 427d4f2d00ffc51edbb1f86fa0224081858aaa3b..cc500661a92a42706a0c5b03b6f2c7fafdbc83dc 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 0000000000000000000000000000000000000000..6a17bae1f0dd83c11b4e501aec66a43e5560b414 --- /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 fba625916d732884fb300bf1acc071c296dcfc19..1dc27ec72b70e9d3e9b033e697770130b96a3fa5 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 6f9c9cf1e6a0546c76a75310af3c93b32d63cef3..bae6296f205b56d6f6a71ad9c71d1aa3e0495965 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 11cfaf95bd913ff7dbf038cf31a316dc7f6a008a..e3c8b375893afbf6665ac0f3d6bf9d3abd745665 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 df146b74f388882fe6c3f8dd863b7bdd3a76a209..0e07c61c65872cf66a11baf8acc7834ae1654727 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 0145c8e18b8838fdc8db0841f04c47a8b5c337fc..9881bbd431b51d78fb7b81b6000aae9d69a61063 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 df146b74f388882fe6c3f8dd863b7bdd3a76a209..0e07c61c65872cf66a11baf8acc7834ae1654727 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 73459cea0720d03956f9bd6cfb7f59f4d60a5d64..dd60bda33acf2f6320084fc74952d4efe1d56c1e 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 2bc00e760c5f775b42ca3d7e9c04c1a63380a7e2..6f84aac5bcbe2ec8e3bf99126d3c6d84705c0079 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 68bdec8486a426e552301e27ed1fcc62821a3b74..8cff40253e8c440373d04e6113a485d761841785 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 2f30a68642aa8acb5d86e90015c274bdf16f6d20..76bbe562b85be6e49545921b25ca1707d03f1b47 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 c36da33bd6a4d2ef1b173782b019c72e458d22d6..e0a0f4efd26185c350d14cd27f8ebb719b593bc1 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 f3fc1aee1393cba861301a3743e7a1d1a3a6d83c..8ce57081a3a51d7c29da4d79237dbb074a5143bf 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 ae7aa33db258ef7719f3ff2174d4d095d2a3ad06..0000000000000000000000000000000000000000 --- 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 ae7aa33db258ef7719f3ff2174d4d095d2a3ad06..0000000000000000000000000000000000000000 --- 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 5c26f07ac45b8192eab967a09e98df31d5cfe919..0000000000000000000000000000000000000000 --- 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 25243dd42f8aff1c422994b6303af87d894424c3..0000000000000000000000000000000000000000 --- 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 7b90a31601b62d6edf96a1054830e415e5170500..0000000000000000000000000000000000000000 --- 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 a4937b503a46850b2626f0d301e4a07b9f691507..0000000000000000000000000000000000000000 --- 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 037e3b47f3c4f7d7527b12ae4005e2a790edcc56..0000000000000000000000000000000000000000 --- 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 57a82196c99d5fab672a6312e4d1ad52da9f0512..0000000000000000000000000000000000000000 --- 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 55b50fd4b41f02830fd3438ff782ce59ec709996..0000000000000000000000000000000000000000 --- 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 9e129840100693b9588d49189ad5637815be529a..0000000000000000000000000000000000000000 --- 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 62bdbb235bf8d1608607b33ca57e82d86c674792..0000000000000000000000000000000000000000 --- 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 f7365e5f6d75e9085d3d5a5d407236b25df92bd5..0000000000000000000000000000000000000000 --- 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 25eb4556791e14389d4a6833174cfa151a6b0188..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..995ea65f2e0d5f23d22c3df1dd30ac0d6d7e457b --- /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 6c92f22050b137d731e89dab0603880abfd0404a..4fac31365501be10892c2f751e29e4b764c9912e 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 inletOutlet; + value uniform ( 0.01 0 0 ); + inletValue uniform ( 0 0 0 ); + } + minY { type fixedValue; - value uniform (0 0 0); + value uniform ( 0 0 0 ); } - - fixedWalls + minZ { type fixedValue; - value uniform (0 0 0); + 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 5babd4b6072c090d5039b47a071be2a775e76a9c..9b51c7b0f88227d88f59c5b545f4bf21ab24556d 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 2b77f184824ad8cf1ebfa24ffe61d639ab425d0e..c09d9c59c9b4c628e383fad7403ca341524eecc6 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 fixedValue; + value uniform 0.01; + } + maxX + { + type inletOutlet; + value uniform 0.01; + inletValue uniform 0.01; + } + minY + { + type compressible::epsilonWallFunction; + value uniform 0.01; + } + minZ + { + type compressible::epsilonWallFunction; + value uniform 0.01; + } + maxZ + { + type compressible::epsilonWallFunction; + value uniform 0.01; + } + bottomWater_to_rightSolid { type compressible::epsilonWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; value uniform 0.01; } - ceiling + bottomWater_to_leftSolid { type compressible::epsilonWallFunction; - Cmu 0.09; - kappa 0.41; - E 9.8; value uniform 0.01; } - fixedWalls + 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 62dd722078f97fe6bafb63653f4d1941347e893a..556c0d3d9ef58cfee3ad06350e2c536b36529abc 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; + } + minZ + { + type compressible::kqRWallFunction; + value uniform 0.1; + } + maxZ + { + type compressible::kqRWallFunction; + value uniform 0.1; + } + bottomWater_to_rightSolid { type compressible::kqRWallFunction; value uniform 0.1; } - ceiling + bottomWater_to_leftSolid { type compressible::kqRWallFunction; value uniform 0.1; } - fixedWalls + 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 881f4c2534a367a6dd650ef80c6e9a097dcd740d..2f81b33af445a55a96e72c47a3cdeecef5adbb2f 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 86029469114e191c8e6061f8f577c434af5349d8..9c7030303907f926511c4ac892805a51d90eb019 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 zeroGradient; + value uniform 0; + } + maxX + { + type fixedValue; + value uniform 0; + } + minY { type fixedFluxPressure; - value uniform 1e5; + value uniform 0; } - - ceiling + minZ { type fixedFluxPressure; - value uniform 1e5; + value uniform 0; } - - fixedWalls + maxZ + { + type fixedFluxPressure; + value uniform 0; + } + bottomWater_to_rightSolid + { + type fixedFluxPressure; + value uniform 0; + } + bottomWater_to_leftSolid { type fixedFluxPressure; - value uniform 1e5; + 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 01acce567027f86bc81805aefd0daaa43cd52369..e3c17b03fb9e73c263102e1e3839582c1f46cbbf 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 e86330c489e1b61103d4a996131c524ee5696d23..9bc9be7feca01b006d2b6b03a4afedfda6a0cfb5 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 c293c032a338e174fa07a88f393f1fbb643c5e6b..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..67ab26120bad0c07675149ebbc4845e4bdf15428 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..08087c37b4d0f37d8df26e11ea195b102f43e32d --- /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 8e1fe39d2c7980ae17ad81c04de4f76700970b79..0666069c2c9fcdc92b408fcc62dd424156d08d8d 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..08087c37b4d0f37d8df26e11ea195b102f43e32d --- /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 09a9a55851d05da7dc6c64a6e800b9f5d0fe7a0e..0000000000000000000000000000000000000000 --- 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 6f32e338356b14a2d7ff55d2d3f7e948dd1e8479..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..fea37570067f9f5dbf14e5011717bb654a2f9899 --- /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 42defceaf42b8ef9bbd7b9f1b61ecf353e66635c..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..583b06cb0b1ff1d19e180d6045ab4f2202a6503a --- /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 213e77a87bbca2706a2912d3ea2cbc1a0f49d37b..c293c032a338e174fa07a88f393f1fbb643c5e6b 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 e63bbc50815e89dfc7ef93352a3228a18620220d..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..ec52cbd5927f5085eeac5ce87f82bd0b9641eeb2 --- /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 8f85c9ef230822d57fecaaf1f86228cbe79f7427..0000000000000000000000000000000000000000 --- 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 0f3e91dd5e3ac819f8a3497cc981d1be132e30ef..0000000000000000000000000000000000000000 --- 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 b6060f54f07065beee96abf9e3c758100d84c60b..0000000000000000000000000000000000000000 --- 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/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSchemes deleted file mode 100644 index 61edc1623f130e7cb1b0cd6b42c21db2957650ff..0000000000000000000000000000000000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/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/multiRegionHeater/system/bottomAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomAir/fvSolution deleted file mode 100644 index b0820c94a58663f8be86b06761f1c1a1f52c9c14..0000000000000000000000000000000000000000 --- 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-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; - } - - 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/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/multiRegionLiquidHeater/system/bottomWater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSchemes similarity index 93% rename from tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/fvSchemes index e08f93840a7704b203c0462d445c5c44c8cc52f3..3051d55b0f4d9088fb23e727693c3342ae0ef68d 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/bottomWater/fvSchemes +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/bottomWater/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/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/controlDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/controlDict index 97f299f8a5a9660522de6174d253ef42a0a9930c..77bc57943a22195b99e062c15412a74652afae32 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/controlDict +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/controlDict @@ -39,7 +39,7 @@ writeInterval 10; purgeWrite 0; -writeFormat binary; +writeFormat ascii; writePrecision 8; @@ -51,7 +51,7 @@ timePrecision 6; runTimeModifiable yes; -maxCo 0.3; +maxCo 0.6; // Maximum diffusion number maxDi 10.0; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/decomposeParDict index 9bdbb31cd254a0189def7c9f126c3dcfaab64f1b..3eb54ba02f72b2b3cd4ed7b5e14d9720e992f463 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/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/changeDictionaryDict index 3c883e6ee28e541f5b7c24d1ab983c1d023a9f6c..a95dd145d5be853f560a30afe4b52bb35e3e9132 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/changeDictionaryDict +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/changeDictionaryDict @@ -51,6 +51,18 @@ dictionaryReplacement kappaName none; value uniform 300; } + + heater_to_leftSolid + { + type compressible::turbulentTemperatureCoupledBaffleMixed; + Tnbr T; + kappa solidThermo; + kappaName none; + thicknessLayers (1e-3); + kappaLayers (5e-4); + value uniform 300; + } + minY { type fixedValue; diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes index 998b93b283bb83b17ebac24f9fda25f633cfe14d..d1227f9fad6317a856ef492515ac93a46c58bcd4 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSchemes @@ -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/multiRegionHeater/system/heater/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSolution index ba8e80d5b9b0ef98c22754581bee0bd94c0aa518..ccb0d3183fb2d698ff0b6b23ca6367efb9adfe00 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/heater/fvSolution @@ -34,7 +34,7 @@ solvers PIMPLE { - nNonOrthogonalCorrectors 1; + nNonOrthogonalCorrectors 0; } // ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict index 987aeb8b43d500d7035a236014457b716e40a6c9..1709662b518d6561e59d932bf3c8f408e7253b21 100644 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict +++ b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/changeDictionaryDict @@ -47,6 +47,17 @@ dictionaryReplacement kappaName none; value uniform 300; } + + leftSolid_to_heater + { + type compressible::turbulentTemperatureCoupledBaffleMixed; + Tnbr T; + kappa solidThermo; + kappaName none; + thicknessLayers (1e-3); + kappaLayers (5e-4); + value uniform 300; + } } } } diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSchemes deleted file mode 100644 index 8fc4915d8ea730e0445655fe5b8732be3226d57a..0000000000000000000000000000000000000000 --- 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 limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -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 0000000000000000000000000000000000000000..63236f302cfd79847ce312cced35784fa149c827 --- /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 ba8e80d5b9b0ef98c22754581bee0bd94c0aa518..0000000000000000000000000000000000000000 --- 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 1; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/leftSolid/fvSolution new file mode 120000 index 0000000000000000000000000000000000000000..0bde0fc62f58a1a111ce897344b26816ef3de04d --- /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 d17c3fadce2d9f41e047ef574381977ea07f9360..0000000000000000000000000000000000000000 --- 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 limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -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 0000000000000000000000000000000000000000..63236f302cfd79847ce312cced35784fa149c827 --- /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 ba8e80d5b9b0ef98c22754581bee0bd94c0aa518..0000000000000000000000000000000000000000 --- 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 1; -} - -// ************************************************************************* // diff --git a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/rightSolid/fvSolution new file mode 120000 index 0000000000000000000000000000000000000000..0bde0fc62f58a1a111ce897344b26816ef3de04d --- /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 e405fc009e174023192077152a7fbf471ebeef03..9bdbb31cd254a0189def7c9f126c3dcfaab64f1b 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 74d5623cb36bac0e4d0fbd7a33fa1a2b2c0b373b..0000000000000000000000000000000000000000 --- 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 limited corrected 0.333; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default limited corrected 0.333; -} - -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 0000000000000000000000000000000000000000..323c0787e29528c483a4560ad3cb1f0542283cfb --- /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 53fcb04628c66bf00b6664beb34463bf521ee634..0000000000000000000000000000000000000000 --- a/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/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/multiRegionHeater/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionHeater/system/topAir/fvSolution new file mode 120000 index 0000000000000000000000000000000000000000..90d9c9234761adbcffeb20601556f39e118ef768 --- /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 bd14f41a4413e5f81b2602609390017c668be423..8f65cab102cf5831c6a33ce37e0f4ba566d0e27a 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 a2e5fd849a6b1abd36df18241cf49c3c9a64c887..0000000000000000000000000000000000000000 --- 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 5c6a42bb1dfd4ab33a7e076968ad74745d385dea..0000000000000000000000000000000000000000 --- 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 0d9e45f046ae33afaa026bd7e1b390ea5d02e0f7..0000000000000000000000000000000000000000 --- 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 c2a485aeac008550cd25ee9abbcdcd49c2711853..0000000000000000000000000000000000000000 --- 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 e20d66145159d55a94d78f8d89ee8f1b1b3543e4..0000000000000000000000000000000000000000 --- 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 351dfc5606e8f86e5bad5cde8f6dd139c2b366b7..0000000000000000000000000000000000000000 --- 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 3e972159635b2a34e38825adaf8a2d6e7c5d77c3..0000000000000000000000000000000000000000 --- 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 8673f6e9bc3a086eabb702e918ae5a5d0f5311fc..0000000000000000000000000000000000000000 --- 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 88b837a3498ba42fa96dd8371f1219bab8dcc5f0..0000000000000000000000000000000000000000 --- 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 b609b24a30b0fd5c160306c50b7e86c204f684f2..0000000000000000000000000000000000000000 --- 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 8462b44418512ac3e5ff8ebd26a3429502f7b9aa..0000000000000000000000000000000000000000 --- 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<volSymmTensorField> 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 09a9a55851d05da7dc6c64a6e800b9f5d0fe7a0e..0000000000000000000000000000000000000000 --- 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 6f32e338356b14a2d7ff55d2d3f7e948dd1e8479..0000000000000000000000000000000000000000 --- 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 42defceaf42b8ef9bbd7b9f1b61ecf353e66635c..0000000000000000000000000000000000000000 --- 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 e63bbc50815e89dfc7ef93352a3228a18620220d..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 dc4d3a18ee4b034d4fdd38eef0466567d0d331bb..0000000000000000000000000000000000000000 --- 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 2a69ccd09ce696a8bb4cfd07ae6973f062207a89..0000000000000000000000000000000000000000 --- 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 59cff17f3fdb426704d79293e125be0164340a18..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 dc4d3a18ee4b034d4fdd38eef0466567d0d331bb..0000000000000000000000000000000000000000 --- 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 09a9a55851d05da7dc6c64a6e800b9f5d0fe7a0e..0000000000000000000000000000000000000000 --- 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 6f32e338356b14a2d7ff55d2d3f7e948dd1e8479..0000000000000000000000000000000000000000 --- 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 46c72c1aa8dd0ed1b4268fdb127c711d861fc031..0000000000000000000000000000000000000000 --- 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 213e77a87bbca2706a2912d3ea2cbc1a0f49d37b..0000000000000000000000000000000000000000 --- 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 e63bbc50815e89dfc7ef93352a3228a18620220d..0000000000000000000000000000000000000000 --- 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 7353934fa806dce69c195563e768ce9557fa18b2..0000000000000000000000000000000000000000 --- 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 d6817628c621dbb7ccba120c825220251d5f9571..0000000000000000000000000000000000000000 --- 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/controlDict b/tutorials/heatTransfer/chtMultiRegionFoam/multiRegionLiquidHeater/system/controlDict deleted file mode 100644 index 27cb568817d3b5088b53a4939a7801ea4a2e3688..0000000000000000000000000000000000000000 --- 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 9bdbb31cd254a0189def7c9f126c3dcfaab64f1b..0000000000000000000000000000000000000000 --- 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 e7d321e95943268ef62b4a5e1d25ebbc469551bb..0000000000000000000000000000000000000000 --- 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 cde9e49189fb2cd3795d3a5649417e7390f543e3..0000000000000000000000000000000000000000 --- 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 94194e9fb45777797c9b5032b2f3c50728134324..0000000000000000000000000000000000000000 --- 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 9bdbb31cd254a0189def7c9f126c3dcfaab64f1b..0000000000000000000000000000000000000000 --- 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 998b93b283bb83b17ebac24f9fda25f633cfe14d..0000000000000000000000000000000000000000 --- 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 35018ad1e4d493067e44e8c15bbdc7f5d7d16955..0000000000000000000000000000000000000000 --- 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 490a05d4adbb11bf21986f590ac4a0118afbf306..0000000000000000000000000000000000000000 --- 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 9bdbb31cd254a0189def7c9f126c3dcfaab64f1b..0000000000000000000000000000000000000000 --- 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 998b93b283bb83b17ebac24f9fda25f633cfe14d..0000000000000000000000000000000000000000 --- 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 0bde0fc62f58a1a111ce897344b26816ef3de04d..0000000000000000000000000000000000000000 --- 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 8993bff833ade11efec6ec23785842cb894ae0e5..0000000000000000000000000000000000000000 --- 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 9bdbb31cd254a0189def7c9f126c3dcfaab64f1b..0000000000000000000000000000000000000000 --- 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 998b93b283bb83b17ebac24f9fda25f633cfe14d..0000000000000000000000000000000000000000 --- 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 0bde0fc62f58a1a111ce897344b26816ef3de04d..0000000000000000000000000000000000000000 --- 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 1eb0bd9f864296069dbbdadc3d45b5b7aa484089..0000000000000000000000000000000000000000 --- 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 9bdbb31cd254a0189def7c9f126c3dcfaab64f1b..0000000000000000000000000000000000000000 --- 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 74d5623cb36bac0e4d0fbd7a33fa1a2b2c0b373b..0000000000000000000000000000000000000000 --- 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 7b840f454fcef6e9a93abba94d570216461607c2..0000000000000000000000000000000000000000 --- 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 8f65cab102cf5831c6a33ce37e0f4ba566d0e27a..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..ee2e56a39ea80ab29cef9f9fe5a0847089c33b01 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..08087c37b4d0f37d8df26e11ea195b102f43e32d --- /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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..08087c37b4d0f37d8df26e11ea195b102f43e32d --- /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 09a9a55851d05da7dc6c64a6e800b9f5d0fe7a0e..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..eaf002d2e96e89052d5371ad0b0aa2da5c665aba --- /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 6f32e338356b14a2d7ff55d2d3f7e948dd1e8479..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..fe0384ff08b952c55e7811f2dc2643afaf6fe706 --- /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 42defceaf42b8ef9bbd7b9f1b61ecf353e66635c..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..e8deee4c2ffe9b4455a8acc5d1e9d0e39c379caa --- /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 213e77a87bbca2706a2912d3ea2cbc1a0f49d37b..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..bd35030a13bd2a596bd156fcb37634090c0342a4 --- /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 e63bbc50815e89dfc7ef93352a3228a18620220d..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..435bf46f771a1525b3b0358a7cb3aea5243f7b91 --- /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 5a81b9a5708b0346c6cdd4bd2f6835feb3700bc1..0000000000000000000000000000000000000000 --- 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 74d5623cb36bac0e4d0fbd7a33fa1a2b2c0b373b..dca5ba3f8e430546245bfd5d281ddf9521587f12 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 998b93b283bb83b17ebac24f9fda25f633cfe14d..8a14cb557add83d24b9323cc85b93c494699093c 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 ba8e80d5b9b0ef98c22754581bee0bd94c0aa518..ccb0d3183fb2d698ff0b6b23ca6367efb9adfe00 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 998b93b283bb83b17ebac24f9fda25f633cfe14d..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..63236f302cfd79847ce312cced35784fa149c827 --- /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 998b93b283bb83b17ebac24f9fda25f633cfe14d..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..63236f302cfd79847ce312cced35784fa149c827 --- /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 a0510435ba3865acace36e1e4b6d678d09aa7baf..bafbafc5180f840dc1b0b22a99e7c421be0db165 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 74d5623cb36bac0e4d0fbd7a33fa1a2b2c0b373b..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..ff6aeb82d395e30f059d8a111d447f5dff18b137 --- /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 72af23d71917318ab5e4c6ce0a448a8fd35e88e6..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..745b2bcfe42a207d4eb7af7dc80b87a460405289 --- /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/heatExchanger/system/air/fvOptions b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/air/fvOptions index e0562a385109a6b6e25313a6189c55ea842a4723..0c2b98d01ff7b85f8524abd1502e66f44b5f49fc 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/air/fvOptions +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/air/fvOptions @@ -46,7 +46,7 @@ porosityBlockage DarcyForchheimerCoeffs { - d d [0 -2 0 0 0] (10 -1000 -1000); + d d [0 -2 0 0 0] (-1000 -1000 1e4); f f [0 -1 0 0 0] (0 0 0); coordinateSystem @@ -75,7 +75,7 @@ MRF1 { origin (0.25 0.25 0.25); axis (0 0 1); - omega 477.5; // 500 rpm + omega 47.7; // 50 rpm } } diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution index fd6da4016c5f88d16188fa4e1a3762d94be588bd..0c19c83955c73b09ea7b025f4077bc9421dfa980 100644 --- a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/heatExchanger/system/porous/fvSolution @@ -29,7 +29,7 @@ solvers agglomerator faceAreaPair; mergeLevels 1; - maxIter 100; + maxIter 10; } "(U|h|e|k|epsilon)" diff --git a/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/T b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeater/0/T deleted file mode 100644 index 65d05cfc73caaf048c613188b57a7a8589d4c5ac..0000000000000000000000000000000000000000 --- 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 ee97b3a9fd3982e9065f256e0daa179adbb7a3f5..0000000000000000000000000000000000000000 --- 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 d2a81a89e27d73d639379d66f1bb7cffaea62156..0000000000000000000000000000000000000000 --- 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 ad5c96dfeedeb0ba98f8f1073039addd102de85d..0000000000000000000000000000000000000000 --- 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 aaf33c77d450869de8ec2f67ce0b7d978dbe430b..0000000000000000000000000000000000000000 --- 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 0bcd7b71907e50226403c21bcd51cdc5d24a5aa5..0000000000000000000000000000000000000000 --- 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 98a5d09794f59e02b90f8a3aabb317329355afb9..0000000000000000000000000000000000000000 --- 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 a0cd6737accf3f4a4b44388263a34b68ceaa706a..0000000000000000000000000000000000000000 --- 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 09a9a55851d05da7dc6c64a6e800b9f5d0fe7a0e..0000000000000000000000000000000000000000 --- 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 6f32e338356b14a2d7ff55d2d3f7e948dd1e8479..0000000000000000000000000000000000000000 --- 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 42defceaf42b8ef9bbd7b9f1b61ecf353e66635c..0000000000000000000000000000000000000000 --- 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 c293c032a338e174fa07a88f393f1fbb643c5e6b..0000000000000000000000000000000000000000 --- 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 e63bbc50815e89dfc7ef93352a3228a18620220d..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 dc4d3a18ee4b034d4fdd38eef0466567d0d331bb..0000000000000000000000000000000000000000 --- 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 2a69ccd09ce696a8bb4cfd07ae6973f062207a89..0000000000000000000000000000000000000000 --- 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 8e1fe39d2c7980ae17ad81c04de4f76700970b79..0000000000000000000000000000000000000000 --- 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 dc4d3a18ee4b034d4fdd38eef0466567d0d331bb..0000000000000000000000000000000000000000 --- 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 09a9a55851d05da7dc6c64a6e800b9f5d0fe7a0e..0000000000000000000000000000000000000000 --- 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 6f32e338356b14a2d7ff55d2d3f7e948dd1e8479..0000000000000000000000000000000000000000 --- 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 42defceaf42b8ef9bbd7b9f1b61ecf353e66635c..0000000000000000000000000000000000000000 --- 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 213e77a87bbca2706a2912d3ea2cbc1a0f49d37b..0000000000000000000000000000000000000000 --- 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 e63bbc50815e89dfc7ef93352a3228a18620220d..0000000000000000000000000000000000000000 --- 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 7e0c2bd5227ae42537bc60e7e21977eec679862a..0000000000000000000000000000000000000000 --- 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 5a81b9a5708b0346c6cdd4bd2f6835feb3700bc1..0000000000000000000000000000000000000000 --- 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 0f3e91dd5e3ac819f8a3497cc981d1be132e30ef..0000000000000000000000000000000000000000 --- 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 3a9d585cca4fb7325a9b344787805522ebcbbe23..0000000000000000000000000000000000000000 --- 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 c5c1935f60b6fa2abe3f518de193d7c408e580ff..0000000000000000000000000000000000000000 --- 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 630fd144ab42224ff2dae7b122a943a600d2152c..0000000000000000000000000000000000000000 --- 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 ce425c291003c679894b31c5df3972b98d42345d..0000000000000000000000000000000000000000 --- 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 9bdbb31cd254a0189def7c9f126c3dcfaab64f1b..0000000000000000000000000000000000000000 --- 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 e7d321e95943268ef62b4a5e1d25ebbc469551bb..0000000000000000000000000000000000000000 --- 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 007d20b6c31f77a26ab9e91be9c3a2e5782a9c7f..0000000000000000000000000000000000000000 --- 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 3c883e6ee28e541f5b7c24d1ab983c1d023a9f6c..0000000000000000000000000000000000000000 --- 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 3a9d585cca4fb7325a9b344787805522ebcbbe23..0000000000000000000000000000000000000000 --- 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 eecf556f634669f3ee5617e83defc916c3237e6d..0000000000000000000000000000000000000000 --- 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 f99b4763eef51439cd2a4451d603d0a5b80943f9..0000000000000000000000000000000000000000 --- 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 987aeb8b43d500d7035a236014457b716e40a6c9..0000000000000000000000000000000000000000 --- 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 f051e7b79a6ca676cbc29eb7a4dd07d805d999a0..0000000000000000000000000000000000000000 --- 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 63236f302cfd79847ce312cced35784fa149c827..0000000000000000000000000000000000000000 --- 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 0bde0fc62f58a1a111ce897344b26816ef3de04d..0000000000000000000000000000000000000000 --- 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 ba99b13705c6d415e7828d3138d85bebb00b4f68..0000000000000000000000000000000000000000 --- 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 864b43c3596b68ad504281f45885b3d5f438afaf..0000000000000000000000000000000000000000 --- 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 63236f302cfd79847ce312cced35784fa149c827..0000000000000000000000000000000000000000 --- 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 0bde0fc62f58a1a111ce897344b26816ef3de04d..0000000000000000000000000000000000000000 --- 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 fef7666e767c70a2c9cf4ab6e41a149436b03e25..0000000000000000000000000000000000000000 --- 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 864b43c3596b68ad504281f45885b3d5f438afaf..0000000000000000000000000000000000000000 --- 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 8acd8191b227f35b2b6ce6d7cb2eaec6fb46293f..0000000000000000000000000000000000000000 --- 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 5db08c0bddf8801d7b76a2a528378f92dce5f89f..0000000000000000000000000000000000000000 --- 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 bd14f41a4413e5f81b2602609390017c668be423..0000000000000000000000000000000000000000 --- 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 ecc9459467659daa24afa9c8c32d84ed8a0d4169..cc0bad0de615d2ef9c58ce467905d04fae0e7858 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 4a3082f0e3eaec0b3ad4ba796eebce760618e830..504cce231e59244c19df82a79ea3d62537659d49 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 073aa8d6e0eece9a17b55d55fc9be0e5e19addf6..380dcfbeaafa083f26e27a6fa00c69f8106df6b6 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..25123622269471dad7f82400d51592d798c34c4b 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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..08087c37b4d0f37d8df26e11ea195b102f43e32d --- /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 a4e4a923dd92ce9c784e49d71de097b2cf890942..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..08087c37b4d0f37d8df26e11ea195b102f43e32d --- /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 09a9a55851d05da7dc6c64a6e800b9f5d0fe7a0e..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..eaf002d2e96e89052d5371ad0b0aa2da5c665aba --- /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 6f32e338356b14a2d7ff55d2d3f7e948dd1e8479..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..fe0384ff08b952c55e7811f2dc2643afaf6fe706 --- /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 00dc28902702d8143dee26a272e35aa564ac97f4..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..e8deee4c2ffe9b4455a8acc5d1e9d0e39c379caa --- /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 213e77a87bbca2706a2912d3ea2cbc1a0f49d37b..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..bd35030a13bd2a596bd156fcb37634090c0342a4 --- /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 e63bbc50815e89dfc7ef93352a3228a18620220d..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..435bf46f771a1525b3b0358a7cb3aea5243f7b91 --- /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 7e0c2bd5227ae42537bc60e7e21977eec679862a..0000000000000000000000000000000000000000 --- 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 69450ffe3af961bbc805e5a7b1a68f39bf5deff0..0000000000000000000000000000000000000000 --- 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 864b43c3596b68ad504281f45885b3d5f438afaf..fd8f4413c36756648a77d24e0c3002bc6e27f6fd 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 864b43c3596b68ad504281f45885b3d5f438afaf..fd8f4413c36756648a77d24e0c3002bc6e27f6fd 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 127c9c965f09ae447303fa4f3c986d44faad8c1c..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..ff6aeb82d395e30f059d8a111d447f5dff18b137 --- /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 98bc0a622bb92acd520d1f1fc276e7a7af5b25c3..0000000000000000000000000000000000000000 --- 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 0000000000000000000000000000000000000000..745b2bcfe42a207d4eb7af7dc80b87a460405289 --- /dev/null +++ b/tutorials/heatTransfer/chtMultiRegionSimpleFoam/multiRegionHeaterRadiation/system/topAir/fvSolution @@ -0,0 +1 @@ +../bottomAir/fvSolution \ No newline at end of file