From 658fa412b5dab392eac4918ca6a84764cdfe0e17 Mon Sep 17 00:00:00 2001 From: Henry Date: Tue, 11 Feb 2014 17:34:50 +0000 Subject: [PATCH] Added fvOptions support to interFoam Now supports MRF MRFInterFoam removed --- .../solvers/multiphase/interFoam/Allwclean | 1 - .../solvers/multiphase/interFoam/Allwmake | 1 - .../interFoam/MRFInterFoam/MRFInterFoam.C | 125 - .../interFoam/MRFInterFoam/Make/files | 3 - .../interFoam/MRFInterFoam/Make/options | 24 - .../multiphase/interFoam/MRFInterFoam/UEqn.H | 38 - .../interFoam/MRFInterFoam/createMRFZones.H | 2 - .../multiphase/interFoam/MRFInterFoam/pEqn.H | 72 - .../interFoam/MRFInterFoam/zonePhaseVolumes.H | 21 - .../solvers/multiphase/interFoam/UEqn.H | 6 + .../solvers/multiphase/interFoam/pEqn.H | 4 +- .../ras/mixerVessel2D/system/fvSolution | 8 +- .../multiphase/MRFInterFoam/mixerVessel2D/0/U | 45 - .../MRFInterFoam/mixerVessel2D/0/alpha.water | 3119 ----------------- .../mixerVessel2D/0/alpha.water.org | 44 - .../MRFInterFoam/mixerVessel2D/0/p_rgh | 44 - .../MRFInterFoam/mixerVessel2D/Allrun | 12 - .../mixerVessel2D/constant/MRFProperties | 31 - .../MRFInterFoam/mixerVessel2D/constant/g | 21 - .../constant/polyMesh/blockMeshDict.m4 | 818 ----- .../mixerVessel2D/constant/polyMesh/boundary | 48 - .../constant/transportProperties | 37 - .../constant/turbulenceProperties | 21 - .../MRFInterFoam/mixerVessel2D/makeMesh | 6 - .../mixerVessel2D/system/controlDict | 56 - .../mixerVessel2D/system/fvSchemes | 60 - .../mixerVessel2D/system/fvSolution | 71 - .../mixerVessel2D/system/setFieldsDict | 36 - .../mixerVessel2D/system/topoSetDict | 32 - .../constant/polyMesh/boundary | 1 + .../damBreakWithObstacle/system/fvSolution | 4 +- 31 files changed, 12 insertions(+), 4799 deletions(-) delete mode 100644 applications/solvers/multiphase/interFoam/MRFInterFoam/MRFInterFoam.C delete mode 100644 applications/solvers/multiphase/interFoam/MRFInterFoam/Make/files delete mode 100644 applications/solvers/multiphase/interFoam/MRFInterFoam/Make/options delete mode 100644 applications/solvers/multiphase/interFoam/MRFInterFoam/UEqn.H delete mode 100644 applications/solvers/multiphase/interFoam/MRFInterFoam/createMRFZones.H delete mode 100644 applications/solvers/multiphase/interFoam/MRFInterFoam/pEqn.H delete mode 100644 applications/solvers/multiphase/interFoam/MRFInterFoam/zonePhaseVolumes.H delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/U delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water.org delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/p_rgh delete mode 100755 tutorials/multiphase/MRFInterFoam/mixerVessel2D/Allrun delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/MRFProperties delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/g delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/blockMeshDict.m4 delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/boundary delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/transportProperties delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/turbulenceProperties delete mode 100755 tutorials/multiphase/MRFInterFoam/mixerVessel2D/makeMesh delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/controlDict delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/fvSchemes delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/fvSolution delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/setFieldsDict delete mode 100644 tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/topoSetDict diff --git a/applications/solvers/multiphase/interFoam/Allwclean b/applications/solvers/multiphase/interFoam/Allwclean index 8b08000667..d91472696f 100755 --- a/applications/solvers/multiphase/interFoam/Allwclean +++ b/applications/solvers/multiphase/interFoam/Allwclean @@ -4,7 +4,6 @@ set -x wclean wclean interDyMFoam -wclean MRFInterFoam wclean porousInterFoam wclean LTSInterFoam wclean interMixingFoam diff --git a/applications/solvers/multiphase/interFoam/Allwmake b/applications/solvers/multiphase/interFoam/Allwmake index cc883614b8..035b007934 100755 --- a/applications/solvers/multiphase/interFoam/Allwmake +++ b/applications/solvers/multiphase/interFoam/Allwmake @@ -4,7 +4,6 @@ set -x wmake wmake interDyMFoam -wmake MRFInterFoam wmake porousInterFoam wmake LTSInterFoam wmake interMixingFoam diff --git a/applications/solvers/multiphase/interFoam/MRFInterFoam/MRFInterFoam.C b/applications/solvers/multiphase/interFoam/MRFInterFoam/MRFInterFoam.C deleted file mode 100644 index ccf89e5467..0000000000 --- a/applications/solvers/multiphase/interFoam/MRFInterFoam/MRFInterFoam.C +++ /dev/null @@ -1,125 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | - \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation - \\/ M anipulation | -------------------------------------------------------------------------------- -License - This file is part of OpenFOAM. - - OpenFOAM is free software: you can redistribute it and/or modify it - under the terms of the GNU General Public License as published by - the Free Software Foundation, either version 3 of the License, or - (at your option) any later version. - - OpenFOAM is distributed in the hope that it will be useful, but WITHOUT - ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or - FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License - for more details. - - You should have received a copy of the GNU General Public License - along with OpenFOAM. If not, see . - -Application - MRFInterFoam - -Description - Solver for 2 incompressible, isothermal immiscible fluids using a VOF - (volume of fluid) phase-fraction based interface capturing approach. - The momentum and other fluid properties are of the "mixture" and a single - momentum equation is solved. - - Turbulence modelling is generic, i.e. laminar, RAS or LES may be selected. - - For a two-fluid approach see twoPhaseEulerFoam. - -\*---------------------------------------------------------------------------*/ - -#include "fvCFD.H" -#include "CMULES.H" -#include "subCycle.H" -#include "interfaceProperties.H" -#include "incompressibleTwoPhaseMixture.H" -#include "turbulenceModel.H" -#include "IOMRFZoneList.H" -#include "pimpleControl.H" -#include "fvIOoptionList.H" -#include "fixedFluxPressureFvPatchScalarField.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -int main(int argc, char *argv[]) -{ - #include "setRootCase.H" - #include "createTime.H" - #include "createMesh.H" - #include "initContinuityErrs.H" - #include "createFields.H" - #include "createMRFZones.H" - #include "readTimeControls.H" - - pimpleControl pimple(mesh); - - #include "createPrghCorrTypes.H" - #include "correctPhi.H" - #include "CourantNo.H" - #include "setInitialDeltaT.H" - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - Info<< "\nStarting time loop\n" << endl; - - while (runTime.run()) - { - #include "readTimeControls.H" - #include "CourantNo.H" - #include "alphaCourantNo.H" - #include "setDeltaT.H" - - runTime++; - - Info<< "Time = " << runTime.timeName() << nl << endl; - - // --- Pressure-velocity PIMPLE corrector loop - while (pimple.loop()) - { - #include "alphaControls.H" - - if (pimple.firstIter() || alphaOuterCorrectors) - { - twoPhaseProperties.correct(); - - #include "alphaEqnSubCycle.H" - interface.correct(); - #include "zonePhaseVolumes.H" - } - - #include "UEqn.H" - - // --- Pressure corrector loop - while (pimple.correct()) - { - #include "pEqn.H" - } - - if (pimple.turbCorr()) - { - turbulence->correct(); - } - } - - runTime.write(); - - Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" - << " ClockTime = " << runTime.elapsedClockTime() << " s" - << nl << endl; - } - - Info<< "End\n" << endl; - - return 0; -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/interFoam/MRFInterFoam/Make/files b/applications/solvers/multiphase/interFoam/MRFInterFoam/Make/files deleted file mode 100644 index 9610e63ee1..0000000000 --- a/applications/solvers/multiphase/interFoam/MRFInterFoam/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -MRFInterFoam.C - -EXE = $(FOAM_APPBIN)/MRFInterFoam diff --git a/applications/solvers/multiphase/interFoam/MRFInterFoam/Make/options b/applications/solvers/multiphase/interFoam/MRFInterFoam/Make/options deleted file mode 100644 index db2e1736ee..0000000000 --- a/applications/solvers/multiphase/interFoam/MRFInterFoam/Make/options +++ /dev/null @@ -1,24 +0,0 @@ -EXE_INC = \ - -I.. \ - -I$(LIB_SRC)/transportModels/twoPhaseMixture/lnInclude \ - -I$(LIB_SRC)/transportModels \ - -I$(LIB_SRC)/transportModels/incompressible/lnInclude \ - -I$(LIB_SRC)/transportModels/interfaceProperties/lnInclude \ - -I$(LIB_SRC)/turbulenceModels/incompressible/turbulenceModel \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/meshTools/lnInclude \ - -I$(LIB_SRC)/fvOptions/lnInclude \ - -I$(LIB_SRC)/sampling/lnInclude - -EXE_LIBS = \ - -ltwoPhaseMixture \ - -linterfaceProperties \ - -ltwoPhaseProperties \ - -lincompressibleTransportModels \ - -lincompressibleTurbulenceModel \ - -lincompressibleRASModels \ - -lincompressibleLESModels \ - -lfiniteVolume \ - -lmeshTools \ - -lfvOptions \ - -lsampling diff --git a/applications/solvers/multiphase/interFoam/MRFInterFoam/UEqn.H b/applications/solvers/multiphase/interFoam/MRFInterFoam/UEqn.H deleted file mode 100644 index c0a9b615a0..0000000000 --- a/applications/solvers/multiphase/interFoam/MRFInterFoam/UEqn.H +++ /dev/null @@ -1,38 +0,0 @@ - surfaceScalarField muEff - ( - "muEff", - twoPhaseProperties.muf() - + fvc::interpolate(rho*turbulence->nut()) - ); - - fvVectorMatrix UEqn - ( - fvm::ddt(rho, U) - + fvm::div(rhoPhi, U) - - fvm::laplacian(muEff, U) - - (fvc::grad(U) & fvc::grad(muEff)) - //- fvc::div(muEff*(fvc::interpolate(dev(fvc::grad(U))) & mesh.Sf())) - == - fvOptions(rho, U) - ); - - mrfZones.addCoriolis(rho, UEqn); - UEqn.relax(); - fvOptions.constrain(UEqn); - - if (pimple.momentumPredictor()) - { - solve - ( - UEqn - == - fvc::reconstruct - ( - ( - fvc::interpolate(interface.sigmaK())*fvc::snGrad(alpha1) - - ghf*fvc::snGrad(rho) - - fvc::snGrad(p_rgh) - ) * mesh.magSf() - ) - ); - } diff --git a/applications/solvers/multiphase/interFoam/MRFInterFoam/createMRFZones.H b/applications/solvers/multiphase/interFoam/MRFInterFoam/createMRFZones.H deleted file mode 100644 index dba2f7ae62..0000000000 --- a/applications/solvers/multiphase/interFoam/MRFInterFoam/createMRFZones.H +++ /dev/null @@ -1,2 +0,0 @@ - IOMRFZoneList mrfZones(mesh); - mrfZones.correctBoundaryVelocity(U); diff --git a/applications/solvers/multiphase/interFoam/MRFInterFoam/pEqn.H b/applications/solvers/multiphase/interFoam/MRFInterFoam/pEqn.H deleted file mode 100644 index 6c315c8eb8..0000000000 --- a/applications/solvers/multiphase/interFoam/MRFInterFoam/pEqn.H +++ /dev/null @@ -1,72 +0,0 @@ -{ - volScalarField rAU("rAU", 1.0/UEqn.A()); - surfaceScalarField rAUf("rAUf", fvc::interpolate(rAU)); - - volVectorField HbyA("HbyA", U); - HbyA = rAU*UEqn.H(); - - surfaceScalarField phiHbyA - ( - "phiHbyA", - (fvc::interpolate(HbyA) & mesh.Sf()) - + fvc::interpolate(rho*rAU)*fvc::ddtCorr(U, phi) - ); - adjustPhi(phiHbyA, U, p_rgh); - mrfZones.makeRelative(phiHbyA); - - surfaceScalarField phig - ( - ( - fvc::interpolate(interface.sigmaK())*fvc::snGrad(alpha1) - - ghf*fvc::snGrad(rho) - )*rAUf*mesh.magSf() - ); - - phiHbyA += phig; - - // Update the fixedFluxPressure BCs to ensure flux consistency - setSnGrad - ( - p_rgh.boundaryField(), - ( - phiHbyA.boundaryField() - - mrfZones.relative(mesh.Sf().boundaryField() & U.boundaryField()) - )/(mesh.magSf().boundaryField()*rAUf.boundaryField()) - ); - - while (pimple.correctNonOrthogonal()) - { - fvScalarMatrix p_rghEqn - ( - fvm::laplacian(rAUf, p_rgh) == fvc::div(phiHbyA) - ); - - p_rghEqn.setReference(pRefCell, getRefCellValue(p_rgh, pRefCell)); - - p_rghEqn.solve(mesh.solver(p_rgh.select(pimple.finalInnerIter()))); - - if (pimple.finalNonOrthogonalIter()) - { - phi = phiHbyA - p_rghEqn.flux(); - - U = HbyA + rAU*fvc::reconstruct((phig - p_rghEqn.flux())/rAUf); - U.correctBoundaryConditions(); - fvOptions.correct(U); - } - } - - #include "continuityErrs.H" - - p == p_rgh + rho*gh; - - if (p_rgh.needReference()) - { - p += dimensionedScalar - ( - "p", - p.dimensions(), - pRefValue - getRefCellValue(p, pRefCell) - ); - p_rgh = p - rho*gh; - } -} diff --git a/applications/solvers/multiphase/interFoam/MRFInterFoam/zonePhaseVolumes.H b/applications/solvers/multiphase/interFoam/MRFInterFoam/zonePhaseVolumes.H deleted file mode 100644 index e0355fe4b1..0000000000 --- a/applications/solvers/multiphase/interFoam/MRFInterFoam/zonePhaseVolumes.H +++ /dev/null @@ -1,21 +0,0 @@ -{ - const scalarField& V = mesh.V(); - - forAll(mesh.cellZones(), czi) - { - const labelList& cellLabels = mesh.cellZones()[czi]; - - scalar phaseVolume = 0; - - forAll(cellLabels, cli) - { - label celli = cellLabels[cli]; - phaseVolume += alpha1[celli]*V[celli]; - } - - reduce(phaseVolume, sumOp()); - - Info<< "Phase volume in zone " << mesh.cellZones()[czi].name() - << " = " << phaseVolume*1e6 << " ml " << endl; - } -} diff --git a/applications/solvers/multiphase/interFoam/UEqn.H b/applications/solvers/multiphase/interFoam/UEqn.H index 7cc250a66a..8cd043123b 100644 --- a/applications/solvers/multiphase/interFoam/UEqn.H +++ b/applications/solvers/multiphase/interFoam/UEqn.H @@ -3,10 +3,14 @@ fvm::ddt(rho, U) + fvm::div(rhoPhi, U) + turbulence->divDevRhoReff(rho, U) + == + fvOptions(rho, U) ); UEqn.relax(); + fvOptions.constrain(UEqn); + if (pimple.momentumPredictor()) { solve @@ -22,4 +26,6 @@ ) * mesh.magSf() ) ); + + fvOptions.correct(U); } diff --git a/applications/solvers/multiphase/interFoam/pEqn.H b/applications/solvers/multiphase/interFoam/pEqn.H index 227c075fa2..51d29b540b 100644 --- a/applications/solvers/multiphase/interFoam/pEqn.H +++ b/applications/solvers/multiphase/interFoam/pEqn.H @@ -11,8 +11,8 @@ (fvc::interpolate(HbyA) & mesh.Sf()) + fvc::interpolate(rho*rAU)*fvc::ddtCorr(U, phi) ); - adjustPhi(phiHbyA, U, p_rgh); + fvOptions.makeRelative(phiHbyA); surfaceScalarField phig ( @@ -30,7 +30,7 @@ p_rgh.boundaryField(), ( phiHbyA.boundaryField() - - (mesh.Sf().boundaryField() & U.boundaryField()) + - fvOptions.relative(mesh.Sf().boundaryField() & U.boundaryField()) )/(mesh.magSf().boundaryField()*rAUf.boundaryField()) ); diff --git a/tutorials/compressible/rhoPimpleFoam/ras/mixerVessel2D/system/fvSolution b/tutorials/compressible/rhoPimpleFoam/ras/mixerVessel2D/system/fvSolution index 825a3a30b2..37cf43261e 100644 --- a/tutorials/compressible/rhoPimpleFoam/ras/mixerVessel2D/system/fvSolution +++ b/tutorials/compressible/rhoPimpleFoam/ras/mixerVessel2D/system/fvSolution @@ -62,14 +62,8 @@ solvers pFinal { - solver GAMG; - tolerance 1e-6; + $p; relTol 0; - smoother GaussSeidel; - cacheAgglomeration true; - nCellsInCoarsestLevel 20; - agglomerator faceAreaPair; - mergeLevels 1; } "(U|h|k|epsilon)" diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/U b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/U deleted file mode 100644 index 500a0fbea1..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/U +++ /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 volVectorField; - location "0"; - object U; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 1 -1 0 0 0 0]; - -internalField uniform (0 0 0); - -boundaryField -{ - rotor - { - type fixedValue; - value uniform (0 0 0); - } - stator - { - type fixedValue; - value uniform (0 0 0); - } - front - { - type empty; - } - back - { - type empty; - } -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water deleted file mode 100644 index 766d8c1462..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water +++ /dev/null @@ -1,3119 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: dev | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class volScalarField; - location "0"; - object alpha.water; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 0 0 0 0]; - -internalField nonuniform List -3072 -( -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -0 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -) -; - -boundaryField -{ - rotor - { - type zeroGradient; - } - stator - { - type zeroGradient; - } - front - { - type empty; - } - back - { - type empty; - } -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water.org b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water.org deleted file mode 100644 index e1483e3c1e..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/alpha.water.org +++ /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 volScalarField; - object alpha.water; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 0 0 0 0]; - -internalField uniform 0; - -boundaryField -{ - rotor - { - type zeroGradient; - } - - stator - { - type zeroGradient; - } - - front - { - type empty; - } - - back - { - type empty; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/p_rgh b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/p_rgh deleted file mode 100644 index dd48a876bc..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/0/p_rgh +++ /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 volScalarField; - object p_rgh; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [1 -1 -2 0 0 0 0]; - -internalField uniform 0; - -boundaryField -{ - rotor - { - type zeroGradient; - } - - stator - { - type zeroGradient; - } - - front - { - type empty; - } - - back - { - type empty; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/Allrun b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/Allrun deleted file mode 100755 index a718eaf7e6..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/Allrun +++ /dev/null @@ -1,12 +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 ./makeMesh -runApplication $application - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/MRFProperties b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/MRFProperties deleted file mode 100644 index 956389e755..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/MRFProperties +++ /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 dictionary; - location "constant"; - object MRFProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -zone1 -{ - cellZone rotor; - active yes; - - // Fixed patches (by default they 'move' with the MRF zone) - nonRotatingPatches (); - - origin (0 0 0); - axis (0 0 1); - omega constant 6.2831853; -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/g b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/g deleted file mode 100644 index d182180d95..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/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 0 0); - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/blockMeshDict.m4 b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/blockMeshDict.m4 deleted file mode 100644 index a93868498b..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/blockMeshDict.m4 +++ /dev/null @@ -1,818 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: 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; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -// General macros to create 2D/extruded-2D meshes - -changecom(//)changequote([,]) -define(calc, [esyscmd(perl -e 'print ($1)')]) -define(VCOUNT, 0) -define(vlabel, [[// ]Vertex $1 = VCOUNT define($1, VCOUNT)define([VCOUNT], incr(VCOUNT))]) -define(pi, 3.14159265) - -define(hex2D, hex ($1b $2b $3b $4b $1t $2t $3t $4t)) -define(quad2D, ($1b $2b $2t $1t)) -define(frontQuad, ($1t $2t $3t $4t)) -define(backQuad, ($1b $4b $3b $2b)) - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -convertToMeters 0.1; - -// Hub radius -define(r, 0.2) - -// Impeller-tip radius -define(rb, 0.5) - -// Baffle-tip radius -define(Rb, 0.7) - -// Tank radius -define(R, 1) - -// MRF region radius -define(ri, calc(0.5*(rb + Rb))) - -// Thickness of 2D slab -define(z, 0.1) - -// Base z -define(Zb, 0) - -// Top z -define(Zt, calc(Zb + z)) - -// Number of cells radially between hub and impeller tip -define(Nr, 12) - -// Number of cells radially in each of the two regions between -// impeller and baffle tips -define(Ni, 4) - -// Number of cells radially between baffle tip and tank -define(NR, 12) - -// Number of cells azimuthally in each of the 8 blocks -define(Na, 12) - -// Number of cells in the thickness of the slab -define(Nz, 1) - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -define(vert, (x$1$2 y$1$2 $3)) -define(evert, (ex$1$2 ey$1$2 $3)) - -define(a0, 0) -define(a1, -45) -define(a2, -90) -define(a3, -135) -define(a4, 180) -define(a5, 135) -define(a6, 90) -define(a7, 45) - -define(ea0, -22.5) -define(ea1, -67.5) -define(ea2, -112.5) -define(ea3, -157.5) -define(ea4, 157.5) -define(ea5, 112.5) -define(ea6, 67.5) -define(ea7, 22.5) - -define(ca0, calc(cos((pi/180)*a0))) -define(ca1, calc(cos((pi/180)*a1))) -define(ca2, calc(cos((pi/180)*a2))) -define(ca3, calc(cos((pi/180)*a3))) -define(ca4, calc(cos((pi/180)*a4))) -define(ca5, calc(cos((pi/180)*a5))) -define(ca6, calc(cos((pi/180)*a6))) -define(ca7, calc(cos((pi/180)*a7))) - -define(sa0, calc(sin((pi/180)*a0))) -define(sa1, calc(sin((pi/180)*a1))) -define(sa2, calc(sin((pi/180)*a2))) -define(sa3, calc(sin((pi/180)*a3))) -define(sa4, calc(sin((pi/180)*a4))) -define(sa5, calc(sin((pi/180)*a5))) -define(sa6, calc(sin((pi/180)*a6))) -define(sa7, calc(sin((pi/180)*a7))) - -define(cea0, calc(cos((pi/180)*ea0))) -define(cea1, calc(cos((pi/180)*ea1))) -define(cea2, calc(cos((pi/180)*ea2))) -define(cea3, calc(cos((pi/180)*ea3))) -define(cea4, calc(cos((pi/180)*ea4))) -define(cea5, calc(cos((pi/180)*ea5))) -define(cea6, calc(cos((pi/180)*ea6))) -define(cea7, calc(cos((pi/180)*ea7))) - -define(sea0, calc(sin((pi/180)*ea0))) -define(sea1, calc(sin((pi/180)*ea1))) -define(sea2, calc(sin((pi/180)*ea2))) -define(sea3, calc(sin((pi/180)*ea3))) -define(sea4, calc(sin((pi/180)*ea4))) -define(sea5, calc(sin((pi/180)*ea5))) -define(sea6, calc(sin((pi/180)*ea6))) -define(sea7, calc(sin((pi/180)*ea7))) - -define(x00, calc(r*ca0)) -define(x01, calc(r*ca1)) -define(x02, calc(r*ca2)) -define(x03, calc(r*ca3)) -define(x04, calc(r*ca4)) -define(x05, calc(r*ca5)) -define(x06, calc(r*ca6)) -define(x07, calc(r*ca7)) - -define(x10, calc(rb*ca0)) -define(x11, calc(rb*ca1)) -define(x12, calc(rb*ca2)) -define(x13, calc(rb*ca3)) -define(x14, calc(rb*ca4)) -define(x15, calc(rb*ca5)) -define(x16, calc(rb*ca6)) -define(x17, calc(rb*ca7)) - -define(x20, calc(ri*ca0)) -define(x21, calc(ri*ca1)) -define(x22, calc(ri*ca2)) -define(x23, calc(ri*ca3)) -define(x24, calc(ri*ca4)) -define(x25, calc(ri*ca5)) -define(x26, calc(ri*ca6)) -define(x27, calc(ri*ca7)) - -define(x30, calc(Rb*ca0)) -define(x31, calc(Rb*ca1)) -define(x32, calc(Rb*ca2)) -define(x33, calc(Rb*ca3)) -define(x34, calc(Rb*ca4)) -define(x35, calc(Rb*ca5)) -define(x36, calc(Rb*ca6)) -define(x37, calc(Rb*ca7)) - -define(x40, calc(R*ca0)) -define(x41, calc(R*ca1)) -define(x42, calc(R*ca2)) -define(x43, calc(R*ca3)) -define(x44, calc(R*ca4)) -define(x45, calc(R*ca5)) -define(x46, calc(R*ca6)) -define(x47, calc(R*ca7)) - -define(y00, calc(r*sa0)) -define(y01, calc(r*sa1)) -define(y02, calc(r*sa2)) -define(y03, calc(r*sa3)) -define(y04, calc(r*sa4)) -define(y05, calc(r*sa5)) -define(y06, calc(r*sa6)) -define(y07, calc(r*sa7)) - -define(y10, calc(rb*sa0)) -define(y11, calc(rb*sa1)) -define(y12, calc(rb*sa2)) -define(y13, calc(rb*sa3)) -define(y14, calc(rb*sa4)) -define(y15, calc(rb*sa5)) -define(y16, calc(rb*sa6)) -define(y17, calc(rb*sa7)) - -define(y20, calc(ri*sa0)) -define(y21, calc(ri*sa1)) -define(y22, calc(ri*sa2)) -define(y23, calc(ri*sa3)) -define(y24, calc(ri*sa4)) -define(y25, calc(ri*sa5)) -define(y26, calc(ri*sa6)) -define(y27, calc(ri*sa7)) - -define(y30, calc(Rb*sa0)) -define(y31, calc(Rb*sa1)) -define(y32, calc(Rb*sa2)) -define(y33, calc(Rb*sa3)) -define(y34, calc(Rb*sa4)) -define(y35, calc(Rb*sa5)) -define(y36, calc(Rb*sa6)) -define(y37, calc(Rb*sa7)) - -define(y40, calc(R*sa0)) -define(y41, calc(R*sa1)) -define(y42, calc(R*sa2)) -define(y43, calc(R*sa3)) -define(y44, calc(R*sa4)) -define(y45, calc(R*sa5)) -define(y46, calc(R*sa6)) -define(y47, calc(R*sa7)) - -define(ex00, calc(r*cea0)) -define(ex01, calc(r*cea1)) -define(ex02, calc(r*cea2)) -define(ex03, calc(r*cea3)) -define(ex04, calc(r*cea4)) -define(ex05, calc(r*cea5)) -define(ex06, calc(r*cea6)) -define(ex07, calc(r*cea7)) - -define(ex10, calc(rb*cea0)) -define(ex11, calc(rb*cea1)) -define(ex12, calc(rb*cea2)) -define(ex13, calc(rb*cea3)) -define(ex14, calc(rb*cea4)) -define(ex15, calc(rb*cea5)) -define(ex16, calc(rb*cea6)) -define(ex17, calc(rb*cea7)) - -define(ex20, calc(ri*cea0)) -define(ex21, calc(ri*cea1)) -define(ex22, calc(ri*cea2)) -define(ex23, calc(ri*cea3)) -define(ex24, calc(ri*cea4)) -define(ex25, calc(ri*cea5)) -define(ex26, calc(ri*cea6)) -define(ex27, calc(ri*cea7)) - -define(ex30, calc(Rb*cea0)) -define(ex31, calc(Rb*cea1)) -define(ex32, calc(Rb*cea2)) -define(ex33, calc(Rb*cea3)) -define(ex34, calc(Rb*cea4)) -define(ex35, calc(Rb*cea5)) -define(ex36, calc(Rb*cea6)) -define(ex37, calc(Rb*cea7)) - -define(ex40, calc(R*cea0)) -define(ex41, calc(R*cea1)) -define(ex42, calc(R*cea2)) -define(ex43, calc(R*cea3)) -define(ex44, calc(R*cea4)) -define(ex45, calc(R*cea5)) -define(ex46, calc(R*cea6)) -define(ex47, calc(R*cea7)) - -define(ey00, calc(r*sea0)) -define(ey01, calc(r*sea1)) -define(ey02, calc(r*sea2)) -define(ey03, calc(r*sea3)) -define(ey04, calc(r*sea4)) -define(ey05, calc(r*sea5)) -define(ey06, calc(r*sea6)) -define(ey07, calc(r*sea7)) - -define(ey10, calc(rb*sea0)) -define(ey11, calc(rb*sea1)) -define(ey12, calc(rb*sea2)) -define(ey13, calc(rb*sea3)) -define(ey14, calc(rb*sea4)) -define(ey15, calc(rb*sea5)) -define(ey16, calc(rb*sea6)) -define(ey17, calc(rb*sea7)) - -define(ey20, calc(ri*sea0)) -define(ey21, calc(ri*sea1)) -define(ey22, calc(ri*sea2)) -define(ey23, calc(ri*sea3)) -define(ey24, calc(ri*sea4)) -define(ey25, calc(ri*sea5)) -define(ey26, calc(ri*sea6)) -define(ey27, calc(ri*sea7)) - -define(ey30, calc(Rb*sea0)) -define(ey31, calc(Rb*sea1)) -define(ey32, calc(Rb*sea2)) -define(ey33, calc(Rb*sea3)) -define(ey34, calc(Rb*sea4)) -define(ey35, calc(Rb*sea5)) -define(ey36, calc(Rb*sea6)) -define(ey37, calc(Rb*sea7)) - -define(ey40, calc(R*sea0)) -define(ey41, calc(R*sea1)) -define(ey42, calc(R*sea2)) -define(ey43, calc(R*sea3)) -define(ey44, calc(R*sea4)) -define(ey45, calc(R*sea5)) -define(ey46, calc(R*sea6)) -define(ey47, calc(R*sea7)) - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -vertices -( - vert(0, 0, Zb) vlabel(r0b) - vert(0, 0, Zb) vlabel(r0sb) - vert(0, 1, Zb) vlabel(r1b) - vert(0, 2, Zb) vlabel(r2b) - vert(0, 2, Zb) vlabel(r2sb) - vert(0, 3, Zb) vlabel(r3b) - vert(0, 4, Zb) vlabel(r4b) - vert(0, 4, Zb) vlabel(r4sb) - vert(0, 5, Zb) vlabel(r5b) - vert(0, 6, Zb) vlabel(r6b) - vert(0, 6, Zb) vlabel(r6sb) - vert(0, 7, Zb) vlabel(r7b) - - vert(1, 0, Zb) vlabel(rb0b) - vert(1, 1, Zb) vlabel(rb1b) - vert(1, 2, Zb) vlabel(rb2b) - vert(1, 3, Zb) vlabel(rb3b) - vert(1, 4, Zb) vlabel(rb4b) - vert(1, 5, Zb) vlabel(rb5b) - vert(1, 6, Zb) vlabel(rb6b) - vert(1, 7, Zb) vlabel(rb7b) - - vert(2, 0, Zb) vlabel(ri0b) - vert(2, 1, Zb) vlabel(ri1b) - vert(2, 2, Zb) vlabel(ri2b) - vert(2, 3, Zb) vlabel(ri3b) - vert(2, 4, Zb) vlabel(ri4b) - vert(2, 5, Zb) vlabel(ri5b) - vert(2, 6, Zb) vlabel(ri6b) - vert(2, 7, Zb) vlabel(ri7b) - - vert(3, 0, Zb) vlabel(Rb0b) - vert(3, 1, Zb) vlabel(Rb1b) - vert(3, 2, Zb) vlabel(Rb2b) - vert(3, 3, Zb) vlabel(Rb3b) - vert(3, 4, Zb) vlabel(Rb4b) - vert(3, 5, Zb) vlabel(Rb5b) - vert(3, 6, Zb) vlabel(Rb6b) - vert(3, 7, Zb) vlabel(Rb7b) - - vert(4, 0, Zb) vlabel(R0b) - vert(4, 1, Zb) vlabel(R1b) - vert(4, 1, Zb) vlabel(R1sb) - vert(4, 2, Zb) vlabel(R2b) - vert(4, 3, Zb) vlabel(R3b) - vert(4, 3, Zb) vlabel(R3sb) - vert(4, 4, Zb) vlabel(R4b) - vert(4, 5, Zb) vlabel(R5b) - vert(4, 5, Zb) vlabel(R5sb) - vert(4, 6, Zb) vlabel(R6b) - vert(4, 7, Zb) vlabel(R7b) - vert(4, 7, Zb) vlabel(R7sb) - - vert(0, 0, Zt) vlabel(r0t) - vert(0, 0, Zt) vlabel(r0st) - vert(0, 1, Zt) vlabel(r1t) - vert(0, 2, Zt) vlabel(r2t) - vert(0, 2, Zt) vlabel(r2st) - vert(0, 3, Zt) vlabel(r3t) - vert(0, 4, Zt) vlabel(r4t) - vert(0, 4, Zt) vlabel(r4st) - vert(0, 5, Zt) vlabel(r5t) - vert(0, 6, Zt) vlabel(r6t) - vert(0, 6, Zt) vlabel(r6st) - vert(0, 7, Zt) vlabel(r7t) - - vert(1, 0, Zt) vlabel(rb0t) - vert(1, 1, Zt) vlabel(rb1t) - vert(1, 2, Zt) vlabel(rb2t) - vert(1, 3, Zt) vlabel(rb3t) - vert(1, 4, Zt) vlabel(rb4t) - vert(1, 5, Zt) vlabel(rb5t) - vert(1, 6, Zt) vlabel(rb6t) - vert(1, 7, Zt) vlabel(rb7t) - - vert(2, 0, Zt) vlabel(ri0t) - vert(2, 1, Zt) vlabel(ri1t) - vert(2, 2, Zt) vlabel(ri2t) - vert(2, 3, Zt) vlabel(ri3t) - vert(2, 4, Zt) vlabel(ri4t) - vert(2, 5, Zt) vlabel(ri5t) - vert(2, 6, Zt) vlabel(ri6t) - vert(2, 7, Zt) vlabel(ri7t) - - vert(3, 0, Zt) vlabel(Rb0t) - vert(3, 1, Zt) vlabel(Rb1t) - vert(3, 2, Zt) vlabel(Rb2t) - vert(3, 3, Zt) vlabel(Rb3t) - vert(3, 4, Zt) vlabel(Rb4t) - vert(3, 5, Zt) vlabel(Rb5t) - vert(3, 6, Zt) vlabel(Rb6t) - vert(3, 7, Zt) vlabel(Rb7t) - - vert(4, 0, Zt) vlabel(R0t) - vert(4, 1, Zt) vlabel(R1t) - vert(4, 1, Zt) vlabel(R1st) - vert(4, 2, Zt) vlabel(R2t) - vert(4, 3, Zt) vlabel(R3t) - vert(4, 3, Zt) vlabel(R3st) - vert(4, 4, Zt) vlabel(R4t) - vert(4, 5, Zt) vlabel(R5t) - vert(4, 5, Zt) vlabel(R5st) - vert(4, 6, Zt) vlabel(R6t) - vert(4, 7, Zt) vlabel(R7t) - vert(4, 7, Zt) vlabel(R7st) -); - -blocks -( - // block0 - hex2D(r0, r1, rb1, rb0) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block1 - hex2D(r1, r2s, rb2, rb1) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block2 - hex2D(r2, r3, rb3, rb2) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block3 - hex2D(r3, r4s, rb4, rb3) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block4 - hex2D(r4, r5, rb5, rb4) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block5 - hex2D(r5, r6s, rb6, rb5) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block6 - hex2D(r6, r7, rb7, rb6) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block7 - hex2D(r7, r0s, rb0, rb7) - rotor - (Na Nr Nz) - simpleGrading (1 1 1) - - // block0 - hex2D(rb0, rb1, ri1, ri0) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block1 - hex2D(rb1, rb2, ri2, ri1) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block2 - hex2D(rb2, rb3, ri3, ri2) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block3 - hex2D(rb3, rb4, ri4, ri3) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block4 - hex2D(rb4, rb5, ri5, ri4) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block5 - hex2D(rb5, rb6, ri6, ri5) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block6 - hex2D(rb6, rb7, ri7, ri6) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block7 - hex2D(rb7, rb0, ri0, ri7) - rotor - (Na Ni Nz) - simpleGrading (1 1 1) - - // block0 - hex2D(ri0, ri1, Rb1, Rb0) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block1 - hex2D(ri1, ri2, Rb2, Rb1) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block2 - hex2D(ri2, ri3, Rb3, Rb2) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block3 - hex2D(ri3, ri4, Rb4, Rb3) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block4 - hex2D(ri4, ri5, Rb5, Rb4) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block5 - hex2D(ri5, ri6, Rb6, Rb5) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block6 - hex2D(ri6, ri7, Rb7, Rb6) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block7 - hex2D(ri7, ri0, Rb0, Rb7) - (Na Ni Nz) - simpleGrading (1 1 1) - - // block0 - hex2D(Rb0, Rb1, R1s, R0) - (Na NR Nz) - simpleGrading (1 1 1) - - // block1 - hex2D(Rb1, Rb2, R2, R1) - (Na NR Nz) - simpleGrading (1 1 1) - - // block2 - hex2D(Rb2, Rb3, R3s, R2) - (Na NR Nz) - simpleGrading (1 1 1) - - // block3 - hex2D(Rb3, Rb4, R4, R3) - (Na NR Nz) - simpleGrading (1 1 1) - - // block4 - hex2D(Rb4, Rb5, R5s, R4) - (Na NR Nz) - simpleGrading (1 1 1) - - // block5 - hex2D(Rb5, Rb6, R6, R5) - (Na NR Nz) - simpleGrading (1 1 1) - - // block6 - hex2D(Rb6, Rb7, R7s, R6) - (Na NR Nz) - simpleGrading (1 1 1) - - // block7 - hex2D(Rb7, Rb0, R0, R7) - (Na NR Nz) - simpleGrading (1 1 1) -); - -edges -( - arc r0b r1b evert(0, 0, Zb) - arc r1b r2sb evert(0, 1, Zb) - arc r2b r3b evert(0, 2, Zb) - arc r3b r4sb evert(0, 3, Zb) - arc r4b r5b evert(0, 4, Zb) - arc r5b r6sb evert(0, 5, Zb) - arc r6b r7b evert(0, 6, Zb) - arc r7b r0sb evert(0, 7, Zb) - - arc rb0b rb1b evert(1, 0, Zb) - arc rb1b rb2b evert(1, 1, Zb) - arc rb2b rb3b evert(1, 2, Zb) - arc rb3b rb4b evert(1, 3, Zb) - arc rb4b rb5b evert(1, 4, Zb) - arc rb5b rb6b evert(1, 5, Zb) - arc rb6b rb7b evert(1, 6, Zb) - arc rb7b rb0b evert(1, 7, Zb) - - arc ri0b ri1b evert(2, 0, Zb) - arc ri1b ri2b evert(2, 1, Zb) - arc ri2b ri3b evert(2, 2, Zb) - arc ri3b ri4b evert(2, 3, Zb) - arc ri4b ri5b evert(2, 4, Zb) - arc ri5b ri6b evert(2, 5, Zb) - arc ri6b ri7b evert(2, 6, Zb) - arc ri7b ri0b evert(2, 7, Zb) - - arc Rb0b Rb1b evert(3, 0, Zb) - arc Rb1b Rb2b evert(3, 1, Zb) - arc Rb2b Rb3b evert(3, 2, Zb) - arc Rb3b Rb4b evert(3, 3, Zb) - arc Rb4b Rb5b evert(3, 4, Zb) - arc Rb5b Rb6b evert(3, 5, Zb) - arc Rb6b Rb7b evert(3, 6, Zb) - arc Rb7b Rb0b evert(3, 7, Zb) - - arc R0b R1sb evert(4, 0, Zb) - arc R1b R2b evert(4, 1, Zb) - arc R2b R3sb evert(4, 2, Zb) - arc R3b R4b evert(4, 3, Zb) - arc R4b R5sb evert(4, 4, Zb) - arc R5b R6b evert(4, 5, Zb) - arc R6b R7sb evert(4, 6, Zb) - arc R7b R0b evert(4, 7, Zb) - - arc r0t r1t evert(0, 0, Zt) - arc r1t r2st evert(0, 1, Zt) - arc r2t r3t evert(0, 2, Zt) - arc r3t r4st evert(0, 3, Zt) - arc r4t r5t evert(0, 4, Zt) - arc r5t r6st evert(0, 5, Zt) - arc r6t r7t evert(0, 6, Zt) - arc r7t r0st evert(0, 7, Zt) - - arc rb0t rb1t evert(1, 0, Zt) - arc rb1t rb2t evert(1, 1, Zt) - arc rb2t rb3t evert(1, 2, Zt) - arc rb3t rb4t evert(1, 3, Zt) - arc rb4t rb5t evert(1, 4, Zt) - arc rb5t rb6t evert(1, 5, Zt) - arc rb6t rb7t evert(1, 6, Zt) - arc rb7t rb0t evert(1, 7, Zt) - - arc ri0t ri1t evert(2, 0, Zt) - arc ri1t ri2t evert(2, 1, Zt) - arc ri2t ri3t evert(2, 2, Zt) - arc ri3t ri4t evert(2, 3, Zt) - arc ri4t ri5t evert(2, 4, Zt) - arc ri5t ri6t evert(2, 5, Zt) - arc ri6t ri7t evert(2, 6, Zt) - arc ri7t ri0t evert(2, 7, Zt) - - arc Rb0t Rb1t evert(3, 0, Zt) - arc Rb1t Rb2t evert(3, 1, Zt) - arc Rb2t Rb3t evert(3, 2, Zt) - arc Rb3t Rb4t evert(3, 3, Zt) - arc Rb4t Rb5t evert(3, 4, Zt) - arc Rb5t Rb6t evert(3, 5, Zt) - arc Rb6t Rb7t evert(3, 6, Zt) - arc Rb7t Rb0t evert(3, 7, Zt) - - arc R0t R1st evert(4, 0, Zt) - arc R1t R2t evert(4, 1, Zt) - arc R2t R3st evert(4, 2, Zt) - arc R3t R4t evert(4, 3, Zt) - arc R4t R5st evert(4, 4, Zt) - arc R5t R6t evert(4, 5, Zt) - arc R6t R7st evert(4, 6, Zt) - arc R7t R0t evert(4, 7, Zt) -); - -patches -( - wall rotor - ( - quad2D(r0, r1) - quad2D(r1, r2s) - quad2D(r2, r3) - quad2D(r3, r4s) - quad2D(r4, r5) - quad2D(r5, r6s) - quad2D(r6, r7) - quad2D(r7, r0s) - - quad2D(r0, rb0) - quad2D(r0s, rb0) - - quad2D(r2, rb2) - quad2D(r2s, rb2) - - quad2D(r4, rb4) - quad2D(r4s, rb4) - - quad2D(r6, rb6) - quad2D(r6s, rb6) - ) - - wall stator - ( - quad2D(R0, R1s) - quad2D(R1, R2) - quad2D(R2, R3s) - quad2D(R3, R4) - quad2D(R4, R5s) - quad2D(R5, R6) - quad2D(R6, R7s) - quad2D(R7, R0) - - quad2D(R1, Rb1) - quad2D(R1s, Rb1) - - quad2D(R3, Rb3) - quad2D(R3s, Rb3) - - quad2D(R5, Rb5) - quad2D(R5s, Rb5) - - quad2D(R7, Rb7) - quad2D(R7s, Rb7) - ) - - empty front - ( - frontQuad(r0, r1, rb1, rb0) - frontQuad(r1, r2s, rb2, rb1) - frontQuad(r2, r3, rb3, rb2) - frontQuad(r3, r4s, rb4, rb3) - frontQuad(r4, r5, rb5, rb4) - frontQuad(r5, r6s, rb6, rb5) - frontQuad(r6, r7, rb7, rb6) - frontQuad(r7, r0s, rb0, rb7) - frontQuad(rb0, rb1, ri1, ri0) - frontQuad(rb1, rb2, ri2, ri1) - frontQuad(rb2, rb3, ri3, ri2) - frontQuad(rb3, rb4, ri4, ri3) - frontQuad(rb4, rb5, ri5, ri4) - frontQuad(rb5, rb6, ri6, ri5) - frontQuad(rb6, rb7, ri7, ri6) - frontQuad(rb7, rb0, ri0, ri7) - frontQuad(ri0, ri1, Rb1, Rb0) - frontQuad(ri1, ri2, Rb2, Rb1) - frontQuad(ri2, ri3, Rb3, Rb2) - frontQuad(ri3, ri4, Rb4, Rb3) - frontQuad(ri4, ri5, Rb5, Rb4) - frontQuad(ri5, ri6, Rb6, Rb5) - frontQuad(ri6, ri7, Rb7, Rb6) - frontQuad(ri7, ri0, Rb0, Rb7) - frontQuad(Rb0, Rb1, R1s, R0) - frontQuad(Rb1, Rb2, R2, R1) - frontQuad(Rb2, Rb3, R3s, R2) - frontQuad(Rb3, Rb4, R4, R3) - frontQuad(Rb4, Rb5, R5s, R4) - frontQuad(Rb5, Rb6, R6, R5) - frontQuad(Rb6, Rb7, R7s, R6) - frontQuad(Rb7, Rb0, R0, R7) - ) - - empty back - ( - backQuad(r0, r1, rb1, rb0) - backQuad(r1, r2s, rb2, rb1) - backQuad(r2, r3, rb3, rb2) - backQuad(r3, r4s, rb4, rb3) - backQuad(r4, r5, rb5, rb4) - backQuad(r5, r6s, rb6, rb5) - backQuad(r6, r7, rb7, rb6) - backQuad(r7, r0s, rb0, rb7) - backQuad(rb0, rb1, ri1, ri0) - backQuad(rb1, rb2, ri2, ri1) - backQuad(rb2, rb3, ri3, ri2) - backQuad(rb3, rb4, ri4, ri3) - backQuad(rb4, rb5, ri5, ri4) - backQuad(rb5, rb6, ri6, ri5) - backQuad(rb6, rb7, ri7, ri6) - backQuad(rb7, rb0, ri0, ri7) - backQuad(ri0, ri1, Rb1, Rb0) - backQuad(ri1, ri2, Rb2, Rb1) - backQuad(ri2, ri3, Rb3, Rb2) - backQuad(ri3, ri4, Rb4, Rb3) - backQuad(ri4, ri5, Rb5, Rb4) - backQuad(ri5, ri6, Rb6, Rb5) - backQuad(ri6, ri7, Rb7, Rb6) - backQuad(ri7, ri0, Rb0, Rb7) - backQuad(Rb0, Rb1, R1s, R0) - backQuad(Rb1, Rb2, R2, R1) - backQuad(Rb2, Rb3, R3s, R2) - backQuad(Rb3, Rb4, R4, R3) - backQuad(Rb4, Rb5, R5s, R4) - backQuad(Rb5, Rb6, R6, R5) - backQuad(Rb6, Rb7, R7s, R6) - backQuad(Rb7, Rb0, R0, R7) - ) -); - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/boundary b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/boundary deleted file mode 100644 index 188a0f0c58..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/polyMesh/boundary +++ /dev/null @@ -1,48 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: 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; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -4 -( - rotor - { - type wall; - nFaces 192; - startFace 5952; - } - stator - { - type wall; - nFaces 192; - startFace 6144; - } - front - { - type empty; - inGroups 1(empty); - nFaces 3072; - startFace 6336; - } - back - { - type empty; - inGroups 1(empty); - nFaces 3072; - startFace 9408; - } -) - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/transportProperties b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/transportProperties deleted file mode 100644 index 15e0e327a4..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/transportProperties +++ /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; - location "constant"; - object transportProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -phases (water oir); - -water -{ - transportModel Newtonian; - nu nu [ 0 2 -1 0 0 0 0 ] 1e-4; - rho rho [ 1 -3 0 0 0 0 0 ] 1000; -} - -oir -{ - transportModel Newtonian; - nu nu [ 0 2 -1 0 0 0 0 ] 1e-4; - rho rho [ 1 -3 0 0 0 0 0 ] 500; -} - -sigma sigma [ 1 0 -2 0 0 0 0 ] 0.05; - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/turbulenceProperties b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/turbulenceProperties deleted file mode 100644 index c2c3b28a1b..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/constant/turbulenceProperties +++ /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; - location "constant"; - object turbulenceProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -simulationType laminar; - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/makeMesh b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/makeMesh deleted file mode 100755 index 8ef4993fde..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/makeMesh +++ /dev/null @@ -1,6 +0,0 @@ -#!/bin/sh - -m4 < constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict -blockMesh -topoSet -setsToZones -noFlipMap diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/controlDict b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/controlDict deleted file mode 100644 index 2c1328db34..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/controlDict +++ /dev/null @@ -1,56 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: 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 MRFInterFoam; - -startFrom startTime; - -startTime 0; - -stopAt endTime; - -endTime 4; - -deltaT 1e-3; - -writeControl adjustableRunTime; - -writeInterval 0.125; - -purgeWrite 0; - -writeFormat ascii; - -writePrecision 6; - -writeCompression uncompressed; - -timeFormat general; - -timePrecision 6; - -runTimeModifiable yes; - -adjustTimeStep yes; - -maxCo 0.5; -maxAlphaCo 0.5; - -maxDeltaT 1; - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/fvSchemes b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/fvSchemes deleted file mode 100644 index a90bcae2d3..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/fvSchemes +++ /dev/null @@ -1,60 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: dev | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object fvSchemes; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -ddtSchemes -{ - default Euler; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - div(rhoPhi,U) Gauss linear; - div(phi,alpha) Gauss vanLeer; - div(phirb,alpha) Gauss linear; - div((muEff*dev(T(grad(U))))) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear corrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default corrected; -} - -fluxRequired -{ - default no; - p_rgh ; - pcorr ; - alpha.water ; -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/fvSolution b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/fvSolution deleted file mode 100644 index 26571a081c..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/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 -{ - alpha.water - { - nAlphaCorr 1; - nAlphaSubCycles 2; - cAlpha 1; - } - - pcorr - { - solver PCG; - preconditioner DIC; - tolerance 1e-10; - relTol 0; - } - - p_rgh - { - solver PCG; - preconditioner DIC; - tolerance 1e-07; - relTol 0.05; - } - - p_rghFinal - { - solver PCG; - preconditioner DIC; - tolerance 1e-07; - relTol 0; - } - - U - { - solver smoothSolver; - smoother symGaussSeidel; - tolerance 1e-06; - relTol 0; - } -} - -PIMPLE -{ - momentumPredictor no; - nCorrectors 3; - nNonOrthogonalCorrectors 0; - - pRefCell 0; - pRefValue 0; -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/setFieldsDict b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/setFieldsDict deleted file mode 100644 index c5884201fc..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/setFieldsDict +++ /dev/null @@ -1,36 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: 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 setFieldsDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -defaultFieldValues -( - volScalarFieldValue alpha.water 0 -); - -regions -( - boxToCell - { - box (0 0 -1) (1 1 1); - fieldValues - ( - volScalarFieldValue alpha.water 1 - ); - } -); - - -// ************************************************************************* // diff --git a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/topoSetDict b/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/topoSetDict deleted file mode 100644 index bf749449bf..0000000000 --- a/tutorials/multiphase/MRFInterFoam/mixerVessel2D/system/topoSetDict +++ /dev/null @@ -1,32 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: 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 topoSetDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -actions -( - { - name rotor; - type cellSet; - action new; - source zoneToCell; - sourceInfo - { - name rotor; - } - } -); - -// ************************************************************************* // diff --git a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary index a30f90f8fb..0a081ddea9 100644 --- a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary +++ b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary @@ -26,6 +26,7 @@ FoamFile walls { type wall; + inGroups 1(wall); nFaces 5376; startFace 94592; } diff --git a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/system/fvSolution b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/system/fvSolution index 22380fc4ae..946f2c0215 100644 --- a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/system/fvSolution +++ b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/system/fvSolution @@ -27,7 +27,7 @@ solvers p_rgh { solver GAMG; - tolerance 1e-08; + tolerance 1e-7; relTol 0.01; smoother DIC; nPreSweeps 0; @@ -48,7 +48,7 @@ solvers "pcorr.*" { $p_rghFinal; - tolerance 0.0001; + tolerance 0.001; } U