diff --git a/applications/solvers/lagrangian/reactingParcelFilmFoam/createFields.H b/applications/solvers/lagrangian/reactingParcelFilmFoam/createFields.H index a5a87c73efdc4b747e903373126a929bcee6901f..e2db33f1f7f64960cd07f9898b039970a63c9b76 100644 --- a/applications/solvers/lagrangian/reactingParcelFilmFoam/createFields.H +++ b/applications/solvers/lagrangian/reactingParcelFilmFoam/createFields.H @@ -88,7 +88,7 @@ Info<< "Calculating field g.h\n" << endl; volScalarField gh("gh", g & mesh.C()); - surfaceScalarField ghf("gh", g & mesh.Cf()); + surfaceScalarField ghf("ghf", g & mesh.Cf()); volScalarField p_rgh ( diff --git a/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H b/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H index bbfb5be051c06d5378b0e15d7f33cff76a19f1a3..5c7a4ae33e30c7b3dd4bf145e5687f500ce8857a 100644 --- a/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H +++ b/applications/solvers/lagrangian/reactingParcelFilmFoam/pEqn.H @@ -1,7 +1,7 @@ rho = thermo.rho(); volScalarField rAU(1.0/UEqn.A()); -surfaceScalarField rhorAUf(rAU.name(), fvc::interpolate(rho*rAU)); +surfaceScalarField rhorAUf(rAU.name() + 'f', fvc::interpolate(rho*rAU)); U = rAU*UEqn.H(); surfaceScalarField phiU diff --git a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/Make/options b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/Make/options index 495defbeec48e847eb02e3d684c8b96de37139f0..cf5b4b09764eea8074ad571a9942bbb1b7b61924 100644 --- a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/Make/options +++ b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/Make/options @@ -18,6 +18,7 @@ EXE_INC = \ -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/SLGThermo/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/radiationModels/lnInclude \ + -I$(LIB_SRC)/combustionModels/lnInclude \ -I$(LIB_SRC)/regionModels/regionModel/lnInclude \ -I$(LIB_SRC)/regionModels/surfaceFilmModels/lnInclude \ -I$(LIB_SRC)/regionModels/pyrolysisModels/lnInclude \ diff --git a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/YhsEqn.H b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/YhsEqn.H index f985a650b9bcc3316f881294058dacb4884e7ab8..aed41a4431359997c531556cab966fd23d2c514e 100644 --- a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/YhsEqn.H +++ b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/YhsEqn.H @@ -13,14 +13,14 @@ tmp<fv::convectionScheme<scalar> > mvConvection combustion->correct(); dQ = combustion->dQ(); label inertIndex = -1; - volScalarField Yt = 0.0*Y[0]; + volScalarField Yt(0.0*Y[0]); forAll(Y, i) { if (Y[i].name() != inertSpecie) { volScalarField& Yi = Y[i]; - fvScalarMatrix R = combustion->R(Yi); + fvScalarMatrix R(combustion->R(Yi)); fvScalarMatrix YiEqn ( @@ -66,7 +66,5 @@ tmp<fv::convectionScheme<scalar> > mvConvection thermo.correct(); - //radiation->correct(); - Info<< "min/max(T) = " << min(T).value() << ", " << max(T).value() << endl; } diff --git a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/createFields.H b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/createFields.H index 96a3457b8378d863a4d44024cd9fc4d5e3730d09..f1e152dc320b47f428e326350f66aae48c947338 100644 --- a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/createFields.H +++ b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/createFields.H @@ -110,7 +110,7 @@ Info<< "Calculating field g.h\n" << endl; volScalarField gh("gh", g & mesh.C()); - surfaceScalarField ghf("gh", g & mesh.Cf()); + surfaceScalarField ghf("ghf", g & mesh.Cf()); volScalarField p_rgh ( diff --git a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/pEqn.H b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/pEqn.H index bbfb5be051c06d5378b0e15d7f33cff76a19f1a3..5c7a4ae33e30c7b3dd4bf145e5687f500ce8857a 100644 --- a/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/pEqn.H +++ b/applications/solvers/lagrangian/reactingParcelFilmPyrolysisFoam/pEqn.H @@ -1,7 +1,7 @@ rho = thermo.rho(); volScalarField rAU(1.0/UEqn.A()); -surfaceScalarField rhorAUf(rAU.name(), fvc::interpolate(rho*rAU)); +surfaceScalarField rhorAUf(rAU.name() + 'f', fvc::interpolate(rho*rAU)); U = rAU*UEqn.H(); surfaceScalarField phiU diff --git a/applications/utilities/miscellaneous/foamDebugSwitches/Make/options b/applications/utilities/miscellaneous/foamDebugSwitches/Make/options index d3072939213f8898184b78f08846af78a27ffa8d..99eae02e71691717374db22d62d9a9ff0d7c0804 100644 --- a/applications/utilities/miscellaneous/foamDebugSwitches/Make/options +++ b/applications/utilities/miscellaneous/foamDebugSwitches/Make/options @@ -62,7 +62,6 @@ EXE_LIBS = \ -lsurfaceFilmModels \ -lsurfMesh \ -lsystemCall \ - -ltabulatedWallFunctions \ -lthermalPorousZone \ -lthermophysicalFunctions \ -ltopoChangerFvMesh \ diff --git a/bin/paraFoam b/bin/paraFoam index a57505f5f9b94ee0ac890fd314c8e87db0f873fe..48eab6ebe0551f01d61893ff29e9998fc19e33c1 100755 --- a/bin/paraFoam +++ b/bin/paraFoam @@ -229,7 +229,8 @@ else echo "created temporary '$caseFile'" } - paraview --data="$caseFile" "$@" + # For now filter out any ld.so errors. Caused by non-system compiler? + paraview --data="$caseFile" "$@" 2>&1 | fgrep -v 'Inconsistency detected by ld.so' fi diff --git a/bin/tools/MakefileDirs b/bin/tools/MakefileDirs index b67656b6e8208087de50f317314837e9eef662e7..7dda83a399dd8a953eb04f550da7fead6ec09efd 100644 --- a/bin/tools/MakefileDirs +++ b/bin/tools/MakefileDirs @@ -36,7 +36,7 @@ application: $(FOAM_TARGETS) $(FOAM_TARGETS): - @(cd $@ && $(FOAM_APP)) + +@(cd $@ && $(FOAM_APP)) #------------------------------------------------------------------------------ diff --git a/bin/tools/RunFunctions b/bin/tools/RunFunctions index bc5ebb5f3282cef7a0f916ae828931303d7e5424..909d902b8abdbf19a2392b3efd20ede2d31195a2 100644 --- a/bin/tools/RunFunctions +++ b/bin/tools/RunFunctions @@ -62,13 +62,13 @@ runParallel() shift echo "Running $APP_RUN in parallel on $PWD using $nProcs processes" - if [ "$WM_SCHEDULER" ] - then - echo "$PWD: $WM_SCHEDULER -np $nProcs" 1>&2 - $WM_SCHEDULER -np $nProcs "( mpirun -np $nProcs $APP_RUN -parallel $* < /dev/null > log.$APP_NAME 2>&1 )" - else + #if [ "$WM_SCHEDULER" ] + #then + # echo "$PWD: $WM_SCHEDULER -np $nProcs" 1>&2 + # $WM_SCHEDULER -np $nProcs "( mpirun -np $nProcs $APP_RUN -parallel $* < /dev/null > log.$APP_NAME 2>&1 )" + #else ( mpirun -np $nProcs $APP_RUN -parallel $* < /dev/null > log.$APP_NAME 2>&1 ) - fi + #fi fi } diff --git a/src/combustionModels/infinitelyFastChemistry/infinitelyFastChemistry.C b/src/combustionModels/infinitelyFastChemistry/infinitelyFastChemistry.C index fb0dbe79b409e3d62409099480e813c6a3e4dbe3..2748e31efa20ff9758d44b584726b4b95427d371 100644 --- a/src/combustionModels/infinitelyFastChemistry/infinitelyFastChemistry.C +++ b/src/combustionModels/infinitelyFastChemistry/infinitelyFastChemistry.C @@ -109,11 +109,13 @@ Foam::combustionModels::infinitelyFastChemistry::R(volScalarField& Y) const const label fNorm = singleMixture_.specieProd()[specieI]; - const volScalarField fres = singleMixture_.fres(specieI); + const volScalarField fres(singleMixture_.fres(specieI)); - const volScalarField wSpecie = + const volScalarField wSpecie + ( wFuelNorm_*singleMixture_.specieStoichCoeffs()[specieI] - / max(fNorm*(Y - fres), scalar(0.001)); + / max(fNorm*(Y - fres), scalar(0.001)) + ); return -fNorm*wSpecie*fres + fNorm*fvm::Sp(wSpecie, Y); } diff --git a/src/finiteVolume/fields/fvPatchFields/derived/directMappedFlowRate/directMappedFlowRateFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/directMappedFlowRate/directMappedFlowRateFvPatchVectorField.C index 3bc74d3e05d1d18fb3281b928e13265db6a0ab42..91ed7d1a2e698e6e3c6d17a227694c23b2870082 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/directMappedFlowRate/directMappedFlowRateFvPatchVectorField.C +++ b/src/finiteVolume/fields/fvPatchFields/derived/directMappedFlowRate/directMappedFlowRateFvPatchVectorField.C @@ -134,9 +134,9 @@ void Foam::directMappedFlowRateFvPatchVectorField::updateCoeffs() const surfaceScalarField& phiName = db().lookupObject<surfaceScalarField>(phiName_); - scalarField U = -phi/patch().magSf(); + scalarField U(-phi/patch().magSf()); - vectorField n = patch().nf(); + vectorField n(patch().nf()); if (phiName.dimensions() == dimVelocity*dimArea) { diff --git a/src/lagrangian/intermediate/clouds/Templates/ThermoCloud/ThermoCloud.C b/src/lagrangian/intermediate/clouds/Templates/ThermoCloud/ThermoCloud.C index 81a14410a5982bfd0802a3c49a6e5646255322c7..f11c29d5549c513fd56dfa6facd23c8aa62a02b4 100644 --- a/src/lagrangian/intermediate/clouds/Templates/ThermoCloud/ThermoCloud.C +++ b/src/lagrangian/intermediate/clouds/Templates/ThermoCloud/ThermoCloud.C @@ -130,7 +130,6 @@ Foam::ThermoCloud<CloudType>::ThermoCloud dimensionedScalar("zero", dimEnergy/dimTemperature, 0.0) ) ) - { if (this->solution().active()) { diff --git a/src/lagrangian/intermediate/parcels/Templates/ThermoParcel/ThermoParcel.H b/src/lagrangian/intermediate/parcels/Templates/ThermoParcel/ThermoParcel.H index 604304a72a84ae135743948e8a2451e50500e48e..fa3c05e80925069adf8fbd3c4f5694fca068891c 100644 --- a/src/lagrangian/intermediate/parcels/Templates/ThermoParcel/ThermoParcel.H +++ b/src/lagrangian/intermediate/parcels/Templates/ThermoParcel/ThermoParcel.H @@ -167,7 +167,7 @@ public: // Private data //- Local copy of carrier specific heat field - // Cp not stored on acrrier thermo, but returned as tmp<...> + // Cp not stored on carrier thermo, but returned as tmp<...> const volScalarField Cp_; diff --git a/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C b/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C index cb0bc500a3d99f056a4e046182b4d64073bb9d47..6a423cd5b6d634b3b1353dea3a7353b34ff5e83b 100644 --- a/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C +++ b/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C @@ -205,6 +205,9 @@ void Foam::SurfaceFilmModel<CloudType>::inject(TrackData& td) tetPtI ); + // Check/set new parcel thermo properties + td.cloud().setParcelThermoProperties(*pPtr, 0.0); + setParcelProperties(*pPtr, j); // Check new parcel properties diff --git a/src/lagrangian/spray/clouds/Templates/SprayCloud/SprayCloud.C b/src/lagrangian/spray/clouds/Templates/SprayCloud/SprayCloud.C index 5b23717b71e0d6c41b63ab76765392ce1d35f3bc..c0cee6bacc2835197e7d7d6d1ab333354a8c7155 100644 --- a/src/lagrangian/spray/clouds/Templates/SprayCloud/SprayCloud.C +++ b/src/lagrangian/spray/clouds/Templates/SprayCloud/SprayCloud.C @@ -345,7 +345,7 @@ void Foam::SprayCloud<CloudType>::motion(TrackData& td) parcelType& p = iter(); if (p.mass() < VSMALL) { - deleteParticle(p); + this->deleteParticle(p); } } } diff --git a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.C b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.C index 6c1925f06414c5b666203f34ec6ea31631c08f0e..8b68e53e6bb6ba7bdca7afc5133b186819d8fc2a 100644 --- a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.C +++ b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.C @@ -648,7 +648,7 @@ Foam::scalarField Foam::autoSnapDriver::calcSnapDistance -GREAT // null value ); - return snapParams.snapTol()*maxEdgeLen; + return scalarField(snapParams.snapTol()*maxEdgeLen); } diff --git a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C index e357dbba655decc10a3046a596725fc1b2b6d0f1..8d2a2b77b260a788888616561d750f4f050d9abd 100644 --- a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C +++ b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C @@ -773,7 +773,7 @@ void Foam::autoSnapDriver::determineAllFeatures labelList nearPointFeat; labelList nearPointIndex; { - scalarField snapDistSqr = sqr(snapDist); + scalarField snapDistSqr(sqr(snapDist)); features.findNearestEdge ( pp.localPoints(), diff --git a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C index 606957c45934ac696dc8136bce79dcaa1b32d16e..6b95d77d03ab57d128de16b8f988056c57e0d2f7 100644 --- a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C +++ b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C @@ -133,8 +133,8 @@ void reactingOneDim::updatePhiGas() const volScalarField& HsiGas = tHsiGas(); const volScalarField& RRiGas = tRRiGas(); - const surfaceScalarField HsiGasf = fvc::interpolate(HsiGas); - const surfaceScalarField RRiGasf = fvc::interpolate(RRiGas); + const surfaceScalarField HsiGasf(fvc::interpolate(HsiGas)); + const surfaceScalarField RRiGasf(fvc::interpolate(RRiGas)); forAll(intCoupledPatchIDs_, i) { @@ -185,7 +185,7 @@ void reactingOneDim::updateMesh(const scalarField& mass0) return; } - const scalarField newV = mass0/rho_; + const scalarField newV(mass0/rho_); Info<< "Initial/final volumes = " << gSum(regionMesh().V()) << ", " << gSum(newV) << " [m3]" << endl; @@ -227,7 +227,7 @@ void reactingOneDim::solveSpeciesMass() Info<< "reactingOneDim::solveSpeciesMass()" << endl; } - volScalarField Yt = 0.0*Ys_[0]; + volScalarField Yt(0.0*Ys_[0]); for (label i=0; i<Ys_.size()-1; i++) { @@ -242,8 +242,10 @@ void reactingOneDim::solveSpeciesMass() if (moveMesh_) { - surfaceScalarField phiRhoMesh = - fvc::interpolate(Yi*rho_)*regionMesh().phi(); + surfaceScalarField phiRhoMesh + ( + fvc::interpolate(Yi*rho_)*regionMesh().phi() + ); YiEqn -= fvc::div(phiRhoMesh); } @@ -264,11 +266,11 @@ void reactingOneDim::solveEnergy() Info<< "reactingOneDim::solveEnergy()" << endl; } - const volScalarField rhoCp = rho_*solidThermo_.Cp(); + const volScalarField rhoCp(rho_*solidThermo_.Cp()); - const surfaceScalarField phiQr = fvc::interpolate(Qr_)*nMagSf(); + const surfaceScalarField phiQr(fvc::interpolate(Qr_)*nMagSf()); - const surfaceScalarField phiGas = fvc::interpolate(phiHsGas_); + const surfaceScalarField phiGas(fvc::interpolate(phiHsGas_)); fvScalarMatrix TEqn ( @@ -282,8 +284,10 @@ void reactingOneDim::solveEnergy() if (moveMesh_) { - surfaceScalarField phiMesh = - fvc::interpolate(rhoCp*T_)*regionMesh().phi(); + surfaceScalarField phiMesh + ( + fvc::interpolate(rhoCp*T_)*regionMesh().phi() + ); TEqn -= fvc::div(phiMesh); } @@ -456,10 +460,12 @@ scalar reactingOneDim::solidRegionDiffNo() const scalar meanDiNum = 0.0; if (regionMesh().nInternalFaces() > 0) { - surfaceScalarField KrhoCpbyDelta = + surfaceScalarField KrhoCpbyDelta + ( regionMesh().surfaceInterpolation::deltaCoeffs() * fvc::interpolate(K_) - / fvc::interpolate(Cp()*rho_); + / fvc::interpolate(Cp()*rho_) + ); DiNum = max(KrhoCpbyDelta.internalField())*time_.deltaTValue(); diff --git a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisVelocityCoupled/filmPyrolysisVelocityCoupledFvPatchVectorField.C b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisVelocityCoupled/filmPyrolysisVelocityCoupledFvPatchVectorField.C index 57955d166cc794aa65d914930d6c6629b52cbb31..b956492d0163c073568e397dd7f20b570b4ba1e8 100644 --- a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisVelocityCoupled/filmPyrolysisVelocityCoupledFvPatchVectorField.C +++ b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisVelocityCoupled/filmPyrolysisVelocityCoupledFvPatchVectorField.C @@ -199,7 +199,7 @@ void Foam::filmPyrolysisVelocityCoupledFvPatchVectorField::updateCoeffs() << exit(FatalError); } - const scalarField UAvePyr = -phiPyr/patch().magSf(); + const scalarField UAvePyr(-phiPyr/patch().magSf()); const vectorField& nf = patch().nf(); forAll(deltaFilm, i) diff --git a/src/sampling/sampledSet/writers/csv/csvSetWriter.C b/src/sampling/sampledSet/writers/csv/csvSetWriter.C index a10205762680c60f46363723b5d52367841ad5c8..8b5e7fa892066cae320122481b1662b3da07aa8d 100644 --- a/src/sampling/sampledSet/writers/csv/csvSetWriter.C +++ b/src/sampling/sampledSet/writers/csv/csvSetWriter.C @@ -76,7 +76,7 @@ void Foam::csvSetWriter<Type>::write columns[i] = valueSets[i]; } - writeTable(points, columns, os); + this->writeTable(points, columns, os); } @@ -110,7 +110,7 @@ void Foam::csvSetWriter<Type>::write columns[i] = &valueSets[i][trackI]; } - writeTable(points[trackI], columns, os); + this->writeTable(points[trackI], columns, os); os << nl << nl; } } diff --git a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C index ee926c706e489da8a063f18944c12ebc45d62857..4da5d82bb158f7cf21e19730d50d55fcc539f7d8 100644 --- a/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C +++ b/src/turbulenceModels/compressible/turbulenceModel/derivedFvPatchFields/temperatureThermoBaffle1D/temperatureThermoBaffle1DFvPatchScalarField.C @@ -230,7 +230,7 @@ void temperatureThermoBaffle1DFvPatchScalarField<solidType>::updateCoeffs() const scalarField Cpw(model.thermo().Cp(Ti, patchI)); - scalarField myh = patch().deltaCoeffs()*alphaw*Cpw; + scalarField myh(patch().deltaCoeffs()*alphaw*Cpw); scalarField alphawCp(alphaw*Cpw); @@ -265,15 +265,16 @@ void temperatureThermoBaffle1DFvPatchScalarField<solidType>::updateCoeffs() scalarField nbrTi(nbrField.patchInternalField()); mpp.map().distribute(nbrTi); - const scalarField nbrCpw = model.thermo().Cp + const scalarField nbrCpw ( - nbrField.patchInternalField(), - nbrPatchI + model.thermo().Cp(nbrField.patchInternalField(), nbrPatchI) ); - scalarField nbrh = + scalarField nbrh + ( nbrPatch.deltaCoeffs()*nbrCpw - *model.alphaEff()().boundaryField()[nbrPatchI]; + *model.alphaEff()().boundaryField()[nbrPatchI] + ); mpp.map().distribute(nbrh); @@ -290,8 +291,11 @@ void temperatureThermoBaffle1DFvPatchScalarField<solidType>::updateCoeffs() KDeltaw[i] = solid_().K((Tp[i] + nbrTp[i])/2.0)/thickness_[i]; } - const scalarField q = - (Ti() - nbrTi)/(1.0/KDeltaw + 1.0/nbrh + 1.0/myh); + const scalarField q + ( + (Ti() - nbrTi)/(1.0/KDeltaw + 1.0/nbrh + 1.0/myh) + ); + forAll(qDot, i) { diff --git a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/G b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/G index 993b5237c3226380e7c25bd56fa6af96997ae926..3ae5fafc79444698d9f8aca27c7ceb72b5feeb0a 100644 --- a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/G +++ b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/0.org/G @@ -26,7 +26,7 @@ boundaryField type MarshakRadiation; T T; emissivityMode lookup; - emissivity 1; + emissivity uniform 1; value uniform 0; refValue uniform 0; refGradient uniform 0; @@ -37,7 +37,7 @@ boundaryField type MarshakRadiation; T T; emissivityMode lookup; - emissivity 1; + emissivity uniform 1; value uniform 0; refValue uniform 0; refGradient uniform 0; diff --git a/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/patchifyObstacles b/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/patchifyObstacles index 8875fc36045bf3fa0471e986bd9c7b244d34b59f..97de34bd9938161786470aab2aa5493b217cd56e 100755 --- a/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/patchifyObstacles +++ b/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/patchifyObstacles @@ -21,8 +21,15 @@ nz=2 tmpSetSet='patchify.setSet' +rm -f patchify.setSet >/dev/null 2>&1 -createSetsAndZone() + +initialiseFaceSet() +{ + echo "faceSet cubeFaces clear" >> $tmpSetSet; +} + +addToFaceSet() { name=$1 x1=$2 @@ -32,13 +39,26 @@ createSetsAndZone() z1=$6 z2=$7 - echo "faceSet ${name} new boxToFace ($x1 $y1 $z1) ($x2 $y2 $z2)" >> $tmpSetSet - echo "cellSet ${name}Cells new faceToCell ${name} owner" >> $tmpSetSet - echo "faceZoneSet ${name} new setsToFaceZone ${name} ${name}Cells" >> $tmpSetSet + echo "faceSet cubeFaces add boxToFace ($x1 $y1 $z1) ($x2 $y2 $z2)" >> $tmpSetSet + echo " $name: (x1=$x1 y1=$y1 z1=$z1) (x2=$x2 y2=$y2 z2=$z2)" +} +createSetsAndZone() +{ + name=$1 + x1=$2 + x2=$3 + y1=$4 + y2=$5 + z1=$6 + z2=$7 + + echo "faceSet ${name}Faces new boxToFace ($x1 $y1 $z1) ($x2 $y2 $z2)" >> $tmpSetSet echo " $name: (x1=$x1 y1=$y1 z1=$z1) (x2=$x2 y2=$y2 z2=$z2)" } +initialiseFaceSet + # loop over cubes n=1 @@ -63,7 +83,7 @@ for xi in $(seq 1 1 $nx); do y2=`echo $y $l $tol | awk '{print $1 + $2 + $3}'` z1=`echo $z $l $tol | awk '{print $1 + $2 - $3}'` z2=`echo $z $l $tol | awk '{print $1 + $2 + $3}'` - createSetsAndZone cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 + addToFaceSet cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 # side 2 side=2 @@ -73,7 +93,7 @@ for xi in $(seq 1 1 $nx); do y2=`echo $y $l $tol | awk '{print $1 + $2 + $3}'` z1=`echo $z $tol | awk '{print $1 - $2}'` z2=`echo $z $l $tol | awk '{print $1 + $2 + $3}'` - createSetsAndZone cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 + addToFaceSet cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 # side 3 side=3 @@ -83,7 +103,7 @@ for xi in $(seq 1 1 $nx); do y2=`echo $y $l $tol | awk '{print $1 + $2 + $3}'` z1=`echo $z $tol | awk '{print $1 - $2}'` z2=`echo $z $tol | awk '{print $1 + $2}'` - createSetsAndZone cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 + addToFaceSet cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 # side 4 side=4 @@ -93,7 +113,7 @@ for xi in $(seq 1 1 $nx); do y2=`echo $y $l $tol | awk '{print $1 + $2 + $3}'` z1=`echo $z $tol | awk '{print $1 - $2}'` z2=`echo $z $l $tol | awk '{print $1 + $2 + $3}'` - createSetsAndZone cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 + addToFaceSet cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 # side 5 side=5 @@ -103,7 +123,7 @@ for xi in $(seq 1 1 $nx); do y2=`echo $y $l $tol | awk '{print $1 + $2 + $3}'` z1=`echo $z $tol | awk '{print $1 - $2}'` z2=`echo $z $l $tol | awk '{print $1 + $2 + $3}'` - createSetsAndZone cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 + addToFaceSet cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 # side 6 side=6 @@ -113,7 +133,7 @@ for xi in $(seq 1 1 $nx); do y2=`echo $y $tol | awk '{print $1 + $2}'` z1=`echo $z $tol | awk '{print $1 - $2}'` z2=`echo $z $l $tol | awk '{print $1 + $2 + $3}'` - createSetsAndZone cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 + addToFaceSet cube${pad}${n}_side${side} $x1 $x2 $y1 $y2 $z1 $z2 let n+=1 @@ -126,12 +146,16 @@ for xi in $(seq 1 1 $nx); do x=`echo $x $offset | awk '{print $1 + $2}'` done +echo "cellSet cubeFacesCells new faceToCell cubeFaces owner" >> $tmpSetSet +echo "faceZoneSet cubeFaces new setsToFaceZone cubeFaces cubeFacesCells" >> $tmpSetSet + echo "processing floor" floorMax=`echo 1 $tol | awk '{print $1 + $2}'` createSetsAndZone floor -$tol $floorMax -$tol $floorMax -$tol $tol +echo "cellSet floorCells new faceToCell floorFaces owner" >> $tmpSetSet +echo "faceZoneSet floorFaces new setsToFaceZone floorFaces floorCells" >> $tmpSetSet -setSet -batch $tmpSetSet >> log.setSet.patchifyObstacles -rm -f $tmpSetSet +setSet -batch $tmpSetSet > log.setSet.patchifyObstacles >/dev/null 2>&1 # ************************************************************************* diff --git a/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/extrudeToRegionMeshDict b/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/extrudeToRegionMeshDict index 8c5cdae28ba0e578548413d03ca5b086c3267ddd..838f1e8c64e36a0995a20ba72e8817852c2174ad 100644 --- a/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/extrudeToRegionMeshDict +++ b/tutorials/lagrangian/reactingParcelFilmFoam/hotBoxes/system/extrudeToRegionMeshDict @@ -18,11 +18,8 @@ region wallFilmRegion; faceZones ( - cube01_side1 cube01_side2 cube01_side3 cube01_side4 cube01_side5 cube01_side6 - cube02_side1 cube02_side2 cube02_side3 cube02_side4 cube02_side5 cube02_side6 - cube03_side1 cube03_side2 cube03_side3 cube03_side4 cube03_side5 cube03_side6 - cube04_side1 cube04_side2 cube04_side3 cube04_side4 cube04_side5 cube04_side6 - floor + cubeFaces + floorFaces ); oneD false;