diff --git a/applications/solvers/multiphase/settlingFoam/Make/files b/applications/solvers/multiphase/settlingFoam/Make/files deleted file mode 100644 index 56beda35d1..0000000000 --- a/applications/solvers/multiphase/settlingFoam/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -settlingFoam.C - -EXE = $(FOAM_APPBIN)/settlingFoam diff --git a/applications/solvers/multiphase/settlingFoam/Make/options b/applications/solvers/multiphase/settlingFoam/Make/options deleted file mode 100644 index fa15f12452..0000000000 --- a/applications/solvers/multiphase/settlingFoam/Make/options +++ /dev/null @@ -1,5 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/finiteVolume/lnInclude - -EXE_LIBS = \ - -lfiniteVolume diff --git a/applications/solvers/multiphase/settlingFoam/UEqn.H b/applications/solvers/multiphase/settlingFoam/UEqn.H deleted file mode 100644 index ff6323bca2..0000000000 --- a/applications/solvers/multiphase/settlingFoam/UEqn.H +++ /dev/null @@ -1,32 +0,0 @@ - // Solve the Momentum equation - - fvVectorMatrix UEqn - ( - fvm::ddt(rho, U) - + fvm::div(phi, U) - + fvc::div - ( - (Alpha/(scalar(1.001) - Alpha))*(sqr(rhoc)/rho)*Vdj*Vdj, - "div(phiVdj,Vdj)" - ) - - fvm::laplacian(muEff, U, "laplacian(muEff,U)") - - (fvc::grad(U) & fvc::grad(muEff)) - ); - - UEqn.relax(); - - if (pimple.momentumPredictor()) - { - solve - ( - UEqn - == - fvc::reconstruct - ( - ( - - ghf*fvc::snGrad(rho) - - fvc::snGrad(p_rgh) - )*mesh.magSf() - ) - ); - } diff --git a/applications/solvers/multiphase/settlingFoam/alphaEqn.H b/applications/solvers/multiphase/settlingFoam/alphaEqn.H deleted file mode 100644 index dccf434d14..0000000000 --- a/applications/solvers/multiphase/settlingFoam/alphaEqn.H +++ /dev/null @@ -1,34 +0,0 @@ -{ - surfaceScalarField phiAlpha - ( - IOobject - ( - "phiAlpha", - runTime.timeName(), - mesh - ), - phi + rhoc*(mesh.Sf() & fvc::interpolate(Vdj)) - ); - - fvScalarMatrix AlphaEqn - ( - fvm::ddt(rho, Alpha) - + fvm::div(phiAlpha, Alpha) - - fvm::laplacian(mut, Alpha) - ); - - AlphaEqn.relax(); - AlphaEqn.solve(); - - Info<< "Solid phase fraction = " - << Alpha.weightedAverage(mesh.V()).value() - << " Min(Alpha) = " << min(Alpha).value() - << " Max(Alpha) = " << max(Alpha).value() - << endl; - - Alpha.min(1.0); - Alpha.max(0.0); - - rho == rhoc/(scalar(1) + (rhoc/rhod - 1.0)*Alpha); - alpha == rho*Alpha/rhod; -} diff --git a/applications/solvers/multiphase/settlingFoam/calcVdj.H b/applications/solvers/multiphase/settlingFoam/calcVdj.H deleted file mode 100644 index a6d9f50570..0000000000 --- a/applications/solvers/multiphase/settlingFoam/calcVdj.H +++ /dev/null @@ -1,20 +0,0 @@ -if (VdjModel == "general") -{ - Vdj = V0* - ( - exp(-a*max(alpha - alphaMin, scalar(0))) - - exp(-a1*max(alpha - alphaMin, scalar(0))) - ); -} -else if (VdjModel == "simple") -{ - Vdj = V0*pow(10.0, -a*alpha); -} -else -{ - FatalErrorIn(args.executable()) - << "Unknown VdjModel : " << VdjModel - << abort(FatalError); -} - -Vdj.correctBoundaryConditions(); diff --git a/applications/solvers/multiphase/settlingFoam/compressibleContinuityErrs.H b/applications/solvers/multiphase/settlingFoam/compressibleContinuityErrs.H deleted file mode 100644 index 96e37e95fb..0000000000 --- a/applications/solvers/multiphase/settlingFoam/compressibleContinuityErrs.H +++ /dev/null @@ -1,21 +0,0 @@ - scalar sumLocalContErr = - runTime.deltaTValue()* - mag - ( - fvc::ddt(rho) - + fvc::div(phi) - )().weightedAverage(rho*mesh.V()).value(); - - scalar globalContErr = - runTime.deltaTValue()* - ( - fvc::ddt(rho) - + fvc::div(phi) - )().weightedAverage(rho*mesh.V()).value(); - - cumulativeContErr += globalContErr; - - Info<< "time step continuity errors : sum local = " << sumLocalContErr - << ", global = " << globalContErr - << ", cumulative = " << cumulativeContErr - << endl; diff --git a/applications/solvers/multiphase/settlingFoam/correctViscosity.H b/applications/solvers/multiphase/settlingFoam/correctViscosity.H deleted file mode 100644 index 0bf086a4f4..0000000000 --- a/applications/solvers/multiphase/settlingFoam/correctViscosity.H +++ /dev/null @@ -1,39 +0,0 @@ -{ - mul = muc + - plasticViscosity - ( - plasticViscosityCoeff, - plasticViscosityExponent, - alpha - ); - - if (BinghamPlastic) - { - volScalarField tauy = yieldStress - ( - yieldStressCoeff, - yieldStressExponent, - yieldStressOffset, - alpha - ); - - mul = - tauy/ - ( - mag(fvc::grad(U)) - + 1.0e-4* - ( - tauy - + dimensionedScalar - ( - "deltaTauy", - tauy.dimensions(), - 1.0e-15 - ) - )/mul - ) - + mul; - } - - mul = min(mul, muMax); -} diff --git a/applications/solvers/multiphase/settlingFoam/createFields.H b/applications/solvers/multiphase/settlingFoam/createFields.H deleted file mode 100644 index 9a9fdee2df..0000000000 --- a/applications/solvers/multiphase/settlingFoam/createFields.H +++ /dev/null @@ -1,383 +0,0 @@ - Info<< "Reading field p_rgh\n" << endl; - volScalarField p_rgh - ( - IOobject - ( - "p_rgh", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - Info<< "Reading field Alpha\n" << endl; - volScalarField Alpha - ( - IOobject - ( - "Alpha", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - Info<< "Reading field U\n" << endl; - volVectorField U - ( - IOobject - ( - "U", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - - Info<< "Reading transportProperties\n" << endl; - - IOdictionary transportProperties - ( - IOobject - ( - "transportProperties", - runTime.constant(), - mesh, - IOobject::MUST_READ_IF_MODIFIED, - IOobject::NO_WRITE - ) - ); - - - dimensionedScalar rhoc(transportProperties.lookup("rhoc")); - - dimensionedScalar rhod(transportProperties.lookup("rhod")); - - dimensionedScalar muc(transportProperties.lookup("muc")); - dimensionedScalar muMax(transportProperties.lookup("muMax")); - - dimensionedScalar plasticViscosityCoeff - ( - transportProperties.lookup("plasticViscosityCoeff") - ); - - dimensionedScalar plasticViscosityExponent - ( - transportProperties.lookup("plasticViscosityExponent") - ); - - dimensionedScalar yieldStressCoeff - ( - transportProperties.lookup("yieldStressCoeff") - ); - - dimensionedScalar yieldStressExponent - ( - transportProperties.lookup("yieldStressExponent") - ); - - dimensionedScalar yieldStressOffset - ( - transportProperties.lookup("yieldStressOffset") - ); - - Switch BinghamPlastic(transportProperties.lookup("BinghamPlastic")); - - volScalarField rho - ( - IOobject - ( - "rho", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::NO_WRITE - ), - rhoc/(scalar(1) + (rhoc/rhod - 1.0)*Alpha) - ); - - volScalarField alpha - ( - IOobject - ( - "alpha", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - rho*Alpha/rhod - ); - - #include "compressibleCreatePhi.H" - - - Info<< "Calculating field mul\n" << endl; - volScalarField mul - ( - IOobject - ( - "mul", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - muc - + plasticViscosity - ( - plasticViscosityCoeff, - plasticViscosityExponent, - Alpha - ) - ); - - - Info<< "Initialising field Vdj\n" << endl; - volVectorField Vdj - ( - IOobject - ( - "Vdj", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - mesh, - dimensionedVector("0.0", U.dimensions(), vector::zero), - U.boundaryField().types() - ); - - - Info<< "Selecting Drift-Flux model " << endl; - - const word VdjModel(transportProperties.lookup("VdjModel")); - - Info<< tab << VdjModel << " selected\n" << endl; - - const dictionary& VdjModelCoeffs - ( - transportProperties.subDict(VdjModel + "Coeffs") - ); - - dimensionedVector V0(VdjModelCoeffs.lookup("V0")); - - dimensionedScalar a(VdjModelCoeffs.lookup("a")); - - dimensionedScalar a1(VdjModelCoeffs.lookup("a1")); - - dimensionedScalar alphaMin(VdjModelCoeffs.lookup("alphaMin")); - - - IOdictionary RASProperties - ( - IOobject - ( - "RASProperties", - runTime.constant(), - mesh, - IOobject::MUST_READ_IF_MODIFIED, - IOobject::NO_WRITE - ) - ); - - - Switch turbulence(RASProperties.lookup("turbulence")); - - dictionary kEpsilonDict(RASProperties.subDictPtr("kEpsilonCoeffs")); - - dimensionedScalar Cmu - ( - dimensionedScalar::lookupOrAddToDict - ( - "Cmu", - kEpsilonDict, - 0.09 - ) - ); - - dimensionedScalar C1 - ( - dimensionedScalar::lookupOrAddToDict - ( - "C1", - kEpsilonDict, - 1.44 - ) - ); - - dimensionedScalar C2 - ( - dimensionedScalar::lookupOrAddToDict - ( - "C2", - kEpsilonDict, - 1.92 - ) - ); - - dimensionedScalar C3 - ( - dimensionedScalar::lookupOrAddToDict - ( - "C3", - kEpsilonDict, - 0.85 - ) - ); - - dimensionedScalar sigmak - ( - dimensionedScalar::lookupOrAddToDict - ( - "sigmak", - kEpsilonDict, - 1.0 - ) - ); - - dimensionedScalar sigmaEps - ( - dimensionedScalar::lookupOrAddToDict - ( - "sigmaEps", - kEpsilonDict, - 1.3 - ) - ); - - dictionary wallFunctionDict(RASProperties.subDictPtr("wallFunctionCoeffs")); - - dimensionedScalar kappa - ( - dimensionedScalar::lookupOrAddToDict - ( - "kappa", - wallFunctionDict, - 0.41 - ) - ); - - dimensionedScalar E - ( - dimensionedScalar::lookupOrAddToDict - ( - "E", - wallFunctionDict, - 9.8 - ) - ); - - if (RASProperties.lookupOrDefault("printCoeffs", false)) - { - Info<< "kEpsilonCoeffs" << kEpsilonDict << nl - << "wallFunctionCoeffs" << wallFunctionDict << endl; - } - - - nearWallDist y(mesh); - - Info<< "Reading field k\n" << endl; - volScalarField k - ( - IOobject - ( - "k", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - Info<< "Reading field epsilon\n" << endl; - volScalarField epsilon - ( - IOobject - ( - "epsilon", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - Info<< "Calculating field mut\n" << endl; - volScalarField mut - ( - IOobject - ( - "mut", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - Cmu*rho*sqr(k)/epsilon - ); - - - Info<< "Calculating field muEff\n" << endl; - volScalarField muEff - ( - IOobject - ( - "muEff", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - mut + mul - ); - - - Info<< "Calculating field (g.h)f\n" << endl; - volScalarField gh("gh", g & mesh.C()); - surfaceScalarField ghf("gh", g & mesh.Cf()); - - volScalarField p - ( - IOobject - ( - "p", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - p_rgh + rho*gh - ); - - label pRefCell = 0; - scalar pRefValue = 0.0; - setRefCell - ( - p, - p_rgh, - mesh.solutionDict().subDict("PIMPLE"), - pRefCell, - pRefValue - ); - - if (p_rgh.needReference()) - { - p += dimensionedScalar - ( - "p", - p.dimensions(), - pRefValue - getRefCellValue(p, pRefCell) - ); - p_rgh = p - rho*gh; - } diff --git a/applications/solvers/multiphase/settlingFoam/kEpsilon.H b/applications/solvers/multiphase/settlingFoam/kEpsilon.H deleted file mode 100644 index d6f983ed27..0000000000 --- a/applications/solvers/multiphase/settlingFoam/kEpsilon.H +++ /dev/null @@ -1,78 +0,0 @@ -if (turbulence) -{ - if (mesh.changing()) - { - y.correct(); - } - - dimensionedScalar k0("k0", k.dimensions(), 0); - dimensionedScalar kMin("kMin", k.dimensions(), SMALL); - dimensionedScalar epsilon0("epsilon0", epsilon.dimensions(), 0); - dimensionedScalar epsilonMin("epsilonMin", epsilon.dimensions(), SMALL); - - volScalarField divU(fvc::div(phi/fvc::interpolate(rho))); - - tmp tgradU = fvc::grad(U); - volScalarField G(2*mut*(tgradU() && dev(symm(tgradU())))); - tgradU.clear(); - - volScalarField Gcoef - ( - Cmu*k/sigmak*(g & fvc::grad(rho))/(epsilon + epsilonMin) - ); - - #include "wallFunctions.H" - - // Dissipation equation - fvScalarMatrix epsEqn - ( - fvm::ddt(rho, epsilon) - + fvm::div(phi, epsilon) - - fvm::laplacian - ( - mut/sigmaEps + muc, epsilon, - "laplacian(DepsilonEff,epsilon)" - ) - == - C1*G*epsilon/(k + kMin) - - fvm::SuSp(C1*(1.0 - C3)*Gcoef + (2.0/3.0*C1)*rho*divU, epsilon) - - fvm::Sp(C2*rho*epsilon/(k + kMin), epsilon) - ); - - #include "wallDissipation.H" - - epsEqn.relax(); - epsEqn.solve(); - - bound(epsilon, epsilon0); - - - // Turbulent kinetic energy equation - fvScalarMatrix kEqn - ( - fvm::ddt(rho, k) - + fvm::div(phi, k) - - fvm::laplacian - ( - mut/sigmak + muc, k, - "laplacian(DkEff,k)" - ) - == - G - - fvm::SuSp(Gcoef + 2.0/3.0*rho*divU, k) - - fvm::Sp(rho*epsilon/(k + kMin), k) - ); - - kEqn.relax(); - kEqn.solve(); - - bound(k, k0); - - - //- Re-calculate viscosity - mut = rho*Cmu*sqr(k)/(epsilon + epsilonMin); - - #include "wallViscosity.H" -} - -muEff = mut + mul; diff --git a/applications/solvers/multiphase/settlingFoam/pEqn.H b/applications/solvers/multiphase/settlingFoam/pEqn.H deleted file mode 100644 index 13c3ddf7ff..0000000000 --- a/applications/solvers/multiphase/settlingFoam/pEqn.H +++ /dev/null @@ -1,70 +0,0 @@ -{ - volScalarField rAU("rAU", 1.0/UEqn.A()); - surfaceScalarField rhorAUf("rhorAUf", fvc::interpolate(rho*rAU)); - - volVectorField HbyA("HbyA", U); - HbyA = rAU*UEqn.H(); - - surfaceScalarField phiHbyA - ( - "phiHbyA", - ( - (fvc::interpolate(rho*HbyA) & mesh.Sf()) - + rhorAUf*fvc::ddtCorr(rho, U, phi) - ) - ); - - surfaceScalarField phig - ( - - ghf*fvc::snGrad(rho)*rhorAUf*mesh.magSf() - ); - - phiHbyA += phig; - - // Update the fixedFluxPressure BCs to ensure flux consistency - setSnGrad - ( - p_rgh.boundaryField(), - ( - phiHbyA.boundaryField() - - (mesh.Sf().boundaryField() & U.boundaryField()) - *rho.boundaryField() - )/(mesh.magSf().boundaryField()*rhorAUf.boundaryField()) - ); - - while (pimple.correctNonOrthogonal()) - { - fvScalarMatrix p_rghEqn - ( - fvm::laplacian(rhorAUf, p_rgh) == fvc::ddt(rho) + 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())/rhorAUf); - U.correctBoundaryConditions(); - } - } - - p == p_rgh + rho*gh; - - if (p_rgh.needReference()) - { - p += dimensionedScalar - ( - "p", - p.dimensions(), - pRefValue - getRefCellValue(p, pRefCell) - ); - p_rgh = p - rho*gh; - } - - #include "rhoEqn.H" - #include "compressibleContinuityErrs.H" -} diff --git a/applications/solvers/multiphase/settlingFoam/plasticViscosity.H b/applications/solvers/multiphase/settlingFoam/plasticViscosity.H deleted file mode 100644 index 2797205a75..0000000000 --- a/applications/solvers/multiphase/settlingFoam/plasticViscosity.H +++ /dev/null @@ -1,17 +0,0 @@ -volScalarField plasticViscosity -( - const dimensionedScalar& plasticViscosityCoeff, - const dimensionedScalar& plasticViscosityExponent, - const volScalarField& alpha -) -{ - tmp tfld - ( - plasticViscosityCoeff* - ( - pow(10.0, plasticViscosityExponent*alpha + SMALL) - scalar(1) - ) - ); - - return tfld(); -} diff --git a/applications/solvers/multiphase/settlingFoam/settlingFoam.C b/applications/solvers/multiphase/settlingFoam/settlingFoam.C deleted file mode 100644 index 3b2454c8bf..0000000000 --- a/applications/solvers/multiphase/settlingFoam/settlingFoam.C +++ /dev/null @@ -1,109 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 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 - settlingFoam - -Description - Solver for 2 incompressible fluids for simulating the settling of the - dispersed phase. - -\*---------------------------------------------------------------------------*/ - -#include "fvCFD.H" -#include "nearWallDist.H" -#include "wallFvPatch.H" -#include "bound.H" -#include "Switch.H" -#include "plasticViscosity.H" -#include "yieldStress.H" -#include "pimpleControl.H" -#include "fixedFluxPressureFvPatchScalarField.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -int main(int argc, char *argv[]) -{ - #include "setRootCase.H" - - #include "createTime.H" - #include "createMesh.H" - #include "readGravitationalAcceleration.H" - #include "createFields.H" - #include "initContinuityErrs.H" - - pimpleControl pimple(mesh); - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - Info<< "\nStarting time loop\n" << endl; - - while (runTime.run()) - { - #include "readTimeControls.H" - #include "compressibleCourantNo.H" - #include "setDeltaT.H" - - runTime++; - - Info<< "Time = " << runTime.timeName() << nl << endl; - - #include "rhoEqn.H" - - // --- Pressure-velocity PIMPLE corrector loop - while (pimple.loop()) - { - #include "calcVdj.H" - - #include "UEqn.H" - - #include "alphaEqn.H" - - #include "correctViscosity.H" - - // --- Pressure corrector loop - while (pimple.correct()) - { - #include "pEqn.H" - } - - if (pimple.turbCorr()) - { - #include "kEpsilon.H" - } - } - - 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/settlingFoam/wallDissipation.H b/applications/solvers/multiphase/settlingFoam/wallDissipation.H deleted file mode 100644 index 14224fd646..0000000000 --- a/applications/solvers/multiphase/settlingFoam/wallDissipation.H +++ /dev/null @@ -1,50 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | - \\ / A nd | Copyright (C) 2011 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 . - -Global - wallDissipation - -Description - Set wall dissipation in the epsilon matrix - -\*---------------------------------------------------------------------------*/ - -{ - const fvPatchList& patches = mesh.boundary(); - - forAll(patches, patchi) - { - const fvPatch& p = patches[patchi]; - - if (isA(p)) - { - epsEqn.setValues - ( - p.faceCells(), - epsilon.boundaryField()[patchi].patchInternalField() - ); - } - } -} - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/settlingFoam/wallFunctions.H b/applications/solvers/multiphase/settlingFoam/wallFunctions.H deleted file mode 100644 index 149d787c59..0000000000 --- a/applications/solvers/multiphase/settlingFoam/wallFunctions.H +++ /dev/null @@ -1,85 +0,0 @@ -{ - labelList cellBoundaryFaceCount(epsilon.size(), 0); - - const scalar Cmu25 = ::pow(Cmu.value(), 0.25); - const scalar Cmu75 = ::pow(Cmu.value(), 0.75); - const scalar kappa_ = kappa.value(); - const scalar muc_ = muc.value(); - - const fvPatchList& patches = mesh.boundary(); - - //- Initialise the near-wall P field to zero - forAll(patches, patchi) - { - const fvPatch& curPatch = patches[patchi]; - - if (isA(curPatch)) - { - forAll(curPatch, facei) - { - label faceCelli = curPatch.faceCells()[facei]; - - epsilon[faceCelli] = 0.0; - G[faceCelli] = 0.0; - } - } - } - - //- Accumulate the wall face contributions to epsilon and G - // Increment cellBoundaryFaceCount for each face for averaging - forAll(patches, patchi) - { - const fvPatch& curPatch = patches[patchi]; - - if (isA(curPatch)) - { - const scalarField& mutw = mut.boundaryField()[patchi]; - - scalarField magFaceGradU - ( - mag(U.boundaryField()[patchi].snGrad()) - ); - - forAll(curPatch, facei) - { - label faceCelli = curPatch.faceCells()[facei]; - - // For corner cells (with two boundary or more faces), - // epsilon and G in the near-wall cell are calculated - // as an average - - cellBoundaryFaceCount[faceCelli]++; - - epsilon[faceCelli] += - Cmu75*::pow(k[faceCelli], 1.5) - /(kappa_*y[patchi][facei]); - - G[faceCelli] += - (mutw[facei] + muc_) - *magFaceGradU[facei] - *Cmu25*::sqrt(k[faceCelli]) - /(kappa_*y[patchi][facei]); - } - } - } - - - // perform the averaging - - forAll(patches, patchi) - { - const fvPatch& curPatch = patches[patchi]; - - if (isA(curPatch)) - { - forAll(curPatch, facei) - { - label faceCelli = curPatch.faceCells()[facei]; - - epsilon[faceCelli] /= cellBoundaryFaceCount[faceCelli]; - G[faceCelli] /= cellBoundaryFaceCount[faceCelli]; - cellBoundaryFaceCount[faceCelli] = 1; - } - } - } -} diff --git a/applications/solvers/multiphase/settlingFoam/wallViscosity.H b/applications/solvers/multiphase/settlingFoam/wallViscosity.H deleted file mode 100644 index d63f7e79b1..0000000000 --- a/applications/solvers/multiphase/settlingFoam/wallViscosity.H +++ /dev/null @@ -1,38 +0,0 @@ -{ - const scalar Cmu25 = ::pow(Cmu.value(), 0.25); - const scalar kappa_ = kappa.value(); - const scalar E_ = E.value(); - const scalar muc_ = muc.value(); - const scalar nuc_ = muc_/rhoc.value(); - - const fvPatchList& patches = mesh.boundary(); - - forAll(patches, patchi) - { - const fvPatch& curPatch = patches[patchi]; - - if (isA(curPatch)) - { - scalarField& mutw = mut.boundaryField()[patchi]; - - forAll(curPatch, facei) - { - label faceCelli = curPatch.faceCells()[facei]; - - scalar yPlus = - Cmu25*y[patchi][facei]*::sqrt(k[faceCelli]) - /nuc_; - - if (yPlus > 11.6) - { - mutw[facei] = - muc_*(yPlus*kappa_/::log(E_*yPlus) - 1); - } - else - { - mutw[facei] = 0.0; - } - } - } - } -} diff --git a/applications/solvers/multiphase/settlingFoam/yieldStress.H b/applications/solvers/multiphase/settlingFoam/yieldStress.H deleted file mode 100644 index cb0415c66f..0000000000 --- a/applications/solvers/multiphase/settlingFoam/yieldStress.H +++ /dev/null @@ -1,19 +0,0 @@ -volScalarField yieldStress -( - const dimensionedScalar& yieldStressCoeff, - const dimensionedScalar& yieldStressExponent, - const dimensionedScalar& yieldStressOffset, - const volScalarField& alpha -) -{ - tmp tfld - ( - yieldStressCoeff* - ( - pow(10.0, yieldStressExponent*(alpha + yieldStressOffset)) - - pow(10.0, yieldStressExponent*yieldStressOffset) - ) - ); - - return tfld(); -} diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/0/Alpha b/tutorials/multiphase/settlingFoam/ras/dahl/0/Alpha deleted file mode 100644 index 1a78d16914..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/0/Alpha +++ /dev/null @@ -1,56 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class volScalarField; - object Alpha; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 0 0 0 0]; - -internalField uniform 0.001; - -boundaryField -{ - inlet - { - type fixedValue; - value $internalField; - } - - outlet - { - type inletOutlet; - inletValue $internalField; - } - - bottomWall - { - type zeroGradient; - } - - endWall - { - type zeroGradient; - } - - top - { - type zeroGradient; - } - - frontAndBack - { - type empty; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/0/U b/tutorials/multiphase/settlingFoam/ras/dahl/0/U deleted file mode 100644 index f44cc68000..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/0/U +++ /dev/null @@ -1,58 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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.0191 0 0); - -boundaryField -{ - inlet - { - type fixedValue; - value $internalField; - } - - outlet - { - type pressureInletOutletVelocity; - value uniform (0 0 0); - } - - bottomWall - { - type fixedValue; - value uniform (0 0 0); - } - - endWall - { - type fixedValue; - value uniform (0 0 0); - } - - top - { - type slip; - } - - frontAndBack - { - type empty; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/0/epsilon b/tutorials/multiphase/settlingFoam/ras/dahl/0/epsilon deleted file mode 100644 index 4824df9d1e..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/0/epsilon +++ /dev/null @@ -1,56 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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 1.50919e-06; - -boundaryField -{ - inlet - { - type fixedValue; - value $internalField; - } - - outlet - { - type inletOutlet; - inletValue $internalField; - } - - bottomWall - { - type zeroGradient; - } - - endWall - { - type zeroGradient; - } - - top - { - type zeroGradient; - } - - frontAndBack - { - type empty; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/0/k b/tutorials/multiphase/settlingFoam/ras/dahl/0/k deleted file mode 100644 index f952e1ce3a..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/0/k +++ /dev/null @@ -1,56 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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.00015; - -boundaryField -{ - inlet - { - type fixedValue; - value $internalField; - } - - outlet - { - type inletOutlet; - inletValue $internalField; - } - - bottomWall - { - type zeroGradient; - } - - endWall - { - type zeroGradient; - } - - top - { - type zeroGradient; - } - - frontAndBack - { - type empty; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/0/p_rgh b/tutorials/multiphase/settlingFoam/ras/dahl/0/p_rgh deleted file mode 100644 index 53b95faad3..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/0/p_rgh +++ /dev/null @@ -1,59 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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 -{ - inlet - { - type fixedFluxPressure; - value uniform 0; - } - - outlet - { - type fixedValue; - value uniform 0; - } - - bottomWall - { - type fixedFluxPressure; - value uniform 0; - } - - endWall - { - type fixedFluxPressure; - value uniform 0; - } - - top - { - type fixedFluxPressure; - value uniform 0; - } - - frontAndBack - { - type empty; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/constant/RASProperties b/tutorials/multiphase/settlingFoam/ras/dahl/constant/RASProperties deleted file mode 100644 index 63c4b0ac47..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/constant/RASProperties +++ /dev/null @@ -1,25 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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/multiphase/settlingFoam/ras/dahl/constant/g b/tutorials/multiphase/settlingFoam/ras/dahl/constant/g deleted file mode 100644 index a4bb6a4135..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/constant/g +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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/multiphase/settlingFoam/ras/dahl/constant/polyMesh/blockMeshDict b/tutorials/multiphase/settlingFoam/ras/dahl/constant/polyMesh/blockMeshDict deleted file mode 100644 index 12604ec56f..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/constant/polyMesh/blockMeshDict +++ /dev/null @@ -1,105 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - object blockMeshDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -convertToMeters 1; - -vertices -( - (0 0 -0.1) - (8.65 0 -0.1) - (8.65 0.1 -0.1) - (0 0.1 -0.1) - (8.65 1 -0.1) - (0 1 -0.1) - (0 0 0.1) - (8.65 0 0.1) - (8.65 0.1 0.1) - (0 0.1 0.1) - (8.65 1 0.1) - (0 1 0.1) -); - -blocks -( - hex (0 1 2 3 6 7 8 9) (200 4 1) simpleGrading (1 1 1) - hex (3 2 4 5 9 8 10 11) (200 36 1) simpleGrading (1 1 1) -); - -edges -( -); - -boundary -( - inlet - { - type patch; - faces - ( - (0 6 9 3) - (3 9 11 5) - ); - } - outlet - { - type patch; - faces - ( - (1 2 8 7) - ); - } - bottomWall - { - type wall; - faces - ( - (0 1 7 6) - ); - } - endWall - { - type wall; - faces - ( - (2 4 10 8) - ); - } - top - { - type patch; - faces - ( - (5 11 10 4) - ); - } - frontAndBack - { - type empty; - faces - ( - (0 3 2 1) - (6 7 8 9) - (3 5 4 2) - (9 8 10 11) - ); - } -); - -mergePatchPairs -( -); - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/constant/transportProperties b/tutorials/multiphase/settlingFoam/ras/dahl/constant/transportProperties deleted file mode 100644 index dd2e55a619..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/constant/transportProperties +++ /dev/null @@ -1,57 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "constant"; - object transportProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -muc muc [ 1 -1 -1 0 0 0 0 ] 0.00178; - -plasticViscosityCoeff plasticViscosityCoeff [ 1 -1 -1 0 0 0 0 ] 0.00023143; - -plasticViscosityExponent plasticViscosityExponent [ 0 0 0 0 0 0 0 ] 179.26; - -BinghamPlastic on; - -yieldStressCoeff yieldStressCoeff [ 1 -1 -2 0 0 0 0 ] 0.00042189; - -yieldStressExponent yieldStressExponent [ 0 0 0 0 0 0 0 ] 1050.8; - -yieldStressOffset yieldStressOffset [ 0 0 0 0 0 0 0 ] 0; - -muMax muMax [ 1 -1 -1 0 0 0 0 ] 10.0; - -rhoc rhoc [ 1 -3 0 0 0 0 0 ] 996; - -rhod rhod [ 1 -3 0 0 0 0 0 ] 1996; - -VdjModel simple; - -simpleCoeffs -{ - V0 V0 [ 0 1 -1 0 0 0 0 ] ( 0 -0.002198 0 ); - a a [ 0 0 0 0 0 0 0 ] 285.84; - a1 a1 [ 0 0 0 0 0 0 0 ] 0; - alphaMin alphaMin [ 0 0 0 0 0 0 0 ] 0; -} - -generalCoeffs -{ - V0 V0 [ 0 1 -1 0 0 0 0 ] ( 0 -0.0018 0 ); - a a [ 0 0 0 0 0 0 0 ] 1e-05; - a1 a1 [ 0 0 0 0 0 0 0 ] 0.1; - alphaMin alphaMin [ 0 0 0 0 0 0 0 ] 2e-05; -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/system/controlDict b/tutorials/multiphase/settlingFoam/ras/dahl/system/controlDict deleted file mode 100644 index 8f56e76e47..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/system/controlDict +++ /dev/null @@ -1,54 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object controlDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -application settlingFoam; - -startFrom latestTime; - -startTime 0; - -stopAt endTime; - -endTime 6400; - -deltaT 0.1; - -writeControl adjustableRunTime; - -writeInterval 20; - -purgeWrite 0; - -writeFormat ascii; - -writePrecision 6; - -writeCompression uncompressed; - -timeFormat general; - -timePrecision 6; - -runTimeModifiable yes; - -adjustTimeStep on; - -maxCo 0.4; - -maxDeltaT 1; - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/system/fvSchemes b/tutorials/multiphase/settlingFoam/ras/dahl/system/fvSchemes deleted file mode 100644 index a4a1eea1b8..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/system/fvSchemes +++ /dev/null @@ -1,61 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object fvSchemes; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -ddtSchemes -{ - default Euler; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - default none; - - div(phi,U) Gauss linearUpwind grad(U); - div(phi,k) Gauss upwind; - div(phi,epsilon) Gauss upwind; - div(phiAlpha,Alpha) Gauss limitedLinear01 1; - div(phiVdj,Vdj) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear corrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default corrected; -} - -fluxRequired -{ - default no; - p_rgh ; -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/system/fvSolution b/tutorials/multiphase/settlingFoam/ras/dahl/system/fvSolution deleted file mode 100644 index 1643923d1e..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/dahl/system/fvSolution +++ /dev/null @@ -1,87 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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-07; - relTol 0.01; - } - - p_rghFinal - { - $p_rgh; - tolerance 1e-07; - relTol 0; - } - - "(U|Alpha|k|epsilon)" - { - solver smoothSolver; - smoother symGaussSeidel; - tolerance 1e-8; - relTol 0.1; - } - - "(U|Alpha|k|epsilon)Final" - { - $k; - tolerance 1e-8; - relTol 0; - } - - rho - { - solver PCG; - preconditioner DIC; - tolerance 1e-8; - relTol 0.1; - } - - rhoFinal - { - $rho; - tolerance 1e-8; - relTol 0; - } -} - -PIMPLE -{ - nCorrectors 3; - nNonOrthogonalCorrectors 0; -} - -relaxationFactors -{ - fields - { - } - equations - { - "Alpha.*" 1; - "U.*" 1; - "k.*" 1; - "epsilon.*" 1; - } -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/0/Alpha b/tutorials/multiphase/settlingFoam/ras/tank3D/0/Alpha deleted file mode 100644 index d0fcf1064d..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/0/Alpha +++ /dev/null @@ -1,126 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class volScalarField; - object Alpha; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -dimensions [0 0 0 0 0 0 0]; - -internalField uniform 0; - -boundaryField -{ - SYMP3 - { - type zeroGradient; - } - - INLE1 - { - type fixedValue; - value uniform 0.002; - } - - OUTL9 - { - type zeroGradient; - } - - OUTL10 - { - type zeroGradient; - } - - OUTL11 - { - type zeroGradient; - } - - OUTL12 - { - type zeroGradient; - } - - WALL6 - { - type zeroGradient; - } - - WALL8 - { - type zeroGradient; - } - - WALL61 - { - type zeroGradient; - } - - WALL62 - { - type zeroGradient; - } - - WALL63 - { - type zeroGradient; - } - - WALL64 - { - type zeroGradient; - } - - WALL65 - { - type zeroGradient; - } - - WALL66 - { - type zeroGradient; - } - - WALL67 - { - type zeroGradient; - } - - WALL68 - { - type zeroGradient; - } - - WALL69 - { - type zeroGradient; - } - - WALL7 - { - type zeroGradient; - } - - WALL70 - { - type zeroGradient; - } - - OUTL15 - { - type inletOutlet; - inletValue uniform 0; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/0/U b/tutorials/multiphase/settlingFoam/ras/tank3D/0/U deleted file mode 100644 index e4fe2c6730..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/0/U +++ /dev/null @@ -1,144 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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 0 0); - -boundaryField -{ - SYMP3 - { - type slip; - } - - INLE1 - { - type fixedValue; - value uniform (0.1315 0 0); - } - - OUTL9 - { - type fixedValue; - value uniform (0 0.0177 0); - } - - OUTL10 - { - type fixedValue; - value uniform (0 0.0177 0); - } - - OUTL11 - { - type fixedValue; - value uniform (0 0.0177 0); - } - - OUTL12 - { - type fixedValue; - value uniform (0 0.0177 0); - } - - WALL6 - { - type translatingWallVelocity; - U (-0.003 0 0); - value uniform (-0.003 0 0); - } - - WALL8 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL61 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL62 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL63 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL64 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL65 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL66 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL67 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL68 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL69 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL7 - { - type fixedValue; - value uniform (0 0 0); - } - - WALL70 - { - type fixedValue; - value uniform (0 0 0); - } - - OUTL15 - { - type inletOutlet; - inletValue uniform (0 0 0); - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/0/epsilon b/tutorials/multiphase/settlingFoam/ras/tank3D/0/epsilon deleted file mode 100644 index 71379ce60f..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/0/epsilon +++ /dev/null @@ -1,126 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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 1.973e-07; - -boundaryField -{ - SYMP3 - { - type zeroGradient; - } - - INLE1 - { - type fixedValue; - value uniform 1.973e-07; - } - - OUTL9 - { - type zeroGradient; - } - - OUTL10 - { - type zeroGradient; - } - - OUTL11 - { - type zeroGradient; - } - - OUTL12 - { - type zeroGradient; - } - - WALL6 - { - type zeroGradient; - } - - WALL8 - { - type zeroGradient; - } - - WALL61 - { - type zeroGradient; - } - - WALL62 - { - type zeroGradient; - } - - WALL63 - { - type zeroGradient; - } - - WALL64 - { - type zeroGradient; - } - - WALL65 - { - type zeroGradient; - } - - WALL66 - { - type zeroGradient; - } - - WALL67 - { - type zeroGradient; - } - - WALL68 - { - type zeroGradient; - } - - WALL69 - { - type zeroGradient; - } - - WALL7 - { - type zeroGradient; - } - - WALL70 - { - type zeroGradient; - } - - OUTL15 - { - type inletOutlet; - inletValue uniform 1.973e-07; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/0/k b/tutorials/multiphase/settlingFoam/ras/tank3D/0/k deleted file mode 100644 index af5dfc635a..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/0/k +++ /dev/null @@ -1,126 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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.000259; - -boundaryField -{ - SYMP3 - { - type zeroGradient; - } - - INLE1 - { - type fixedValue; - value uniform 0.000259; - } - - OUTL9 - { - type zeroGradient; - } - - OUTL10 - { - type zeroGradient; - } - - OUTL11 - { - type zeroGradient; - } - - OUTL12 - { - type zeroGradient; - } - - WALL6 - { - type zeroGradient; - } - - WALL8 - { - type zeroGradient; - } - - WALL61 - { - type zeroGradient; - } - - WALL62 - { - type zeroGradient; - } - - WALL63 - { - type zeroGradient; - } - - WALL64 - { - type zeroGradient; - } - - WALL65 - { - type zeroGradient; - } - - WALL66 - { - type zeroGradient; - } - - WALL67 - { - type zeroGradient; - } - - WALL68 - { - type zeroGradient; - } - - WALL69 - { - type zeroGradient; - } - - WALL7 - { - type zeroGradient; - } - - WALL70 - { - type zeroGradient; - } - - OUTL15 - { - type inletOutlet; - inletValue uniform 0.000259; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/0/p_rgh b/tutorials/multiphase/settlingFoam/ras/tank3D/0/p_rgh deleted file mode 100644 index e2b65cee23..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/0/p_rgh +++ /dev/null @@ -1,144 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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 -{ - SYMP3 - { - type fixedFluxPressure; - value uniform 0; - } - - INLE1 - { - type fixedFluxPressure; - value uniform 0; - } - - OUTL9 - { - type fixedFluxPressure; - value uniform 0; - } - - OUTL10 - { - type fixedFluxPressure; - value uniform 0; - } - - OUTL11 - { - type fixedFluxPressure; - value uniform 0; - } - - OUTL12 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL6 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL8 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL61 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL62 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL63 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL64 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL65 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL66 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL67 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL68 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL69 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL7 - { - type fixedFluxPressure; - value uniform 0; - } - - WALL70 - { - type fixedFluxPressure; - value uniform 0; - } - - OUTL15 - { - type fixedValue; - value uniform 0; - } -} - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/Allclean b/tutorials/multiphase/settlingFoam/ras/tank3D/Allclean deleted file mode 100755 index cd0a5ef764..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/Allclean +++ /dev/null @@ -1,9 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory - -# Clean time directories only - -rm -rf *[1-9]* -rm -f log.* 2>/dev/null - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/Allrun b/tutorials/multiphase/settlingFoam/ras/tank3D/Allrun deleted file mode 100755 index 581f444839..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/Allrun +++ /dev/null @@ -1,11 +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 $application - -# ----------------------------------------------------------------- end-of-file diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/RASProperties b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/RASProperties deleted file mode 100644 index 63c4b0ac47..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/RASProperties +++ /dev/null @@ -1,25 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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/multiphase/settlingFoam/ras/tank3D/constant/g b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/g deleted file mode 100644 index abca4e1462..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/g +++ /dev/null @@ -1,22 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/boundary b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/boundary deleted file mode 100644 index 50b80a3ee8..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/boundary +++ /dev/null @@ -1,160 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class polyBoundaryMesh; - object boundary; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -( - SYMP3 - { - type patch; - startFace 53708; - nFaces 3191; - } - - INLE1 - { - type patch; - startFace 56899; - nFaces 45; - } - - OUTL9 - { - type patch; - startFace 56944; - nFaces 11; - } - - OUTL10 - { - type patch; - startFace 56955; - nFaces 11; - } - - OUTL11 - { - type patch; - startFace 56966; - nFaces 11; - } - - OUTL12 - { - type patch; - startFace 56977; - nFaces 11; - } - - WALL6 - { - type wall; - startFace 56988; - nFaces 1474; - } - - WALL8 - { - type wall; - startFace 58462; - nFaces 1640; - } - - WALL61 - { - type wall; - startFace 60102; - nFaces 44; - } - - WALL62 - { - type wall; - startFace 60146; - nFaces 78; - } - - WALL63 - { - type wall; - startFace 60224; - nFaces 255; - } - - WALL64 - { - type wall; - startFace 60479; - nFaces 157; - } - - WALL65 - { - type wall; - startFace 60636; - nFaces 35; - } - - WALL66 - { - type wall; - startFace 60671; - nFaces 60; - } - - WALL67 - { - type wall; - startFace 60731; - nFaces 55; - } - - WALL68 - { - type wall; - startFace 60786; - nFaces 116; - } - - WALL69 - { - type wall; - startFace 60902; - nFaces 24; - } - - WALL7 - { - type wall; - startFace 60926; - nFaces 121; - } - - WALL70 - { - type wall; - startFace 61047; - nFaces 182; - } - - OUTL15 - { - type patch; - startFace 61229; - nFaces 14; - } - -) - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/cells.gz b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/cells.gz deleted file mode 100644 index 24502150fa..0000000000 Binary files a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/cells.gz and /dev/null differ diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/faces.gz b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/faces.gz deleted file mode 100644 index f3128af86b..0000000000 Binary files a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/faces.gz and /dev/null differ diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/neighbour.gz b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/neighbour.gz deleted file mode 100644 index ac50368238..0000000000 Binary files a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/neighbour.gz and /dev/null differ diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/owner.gz b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/owner.gz deleted file mode 100644 index 740055841e..0000000000 Binary files a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/owner.gz and /dev/null differ diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/points.gz b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/points.gz deleted file mode 100644 index 2b3d565045..0000000000 Binary files a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/polyMesh/points.gz and /dev/null differ diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/transportProperties b/tutorials/multiphase/settlingFoam/ras/tank3D/constant/transportProperties deleted file mode 100644 index 4a5cb9f228..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/constant/transportProperties +++ /dev/null @@ -1,57 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "constant"; - object transportProperties; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -muc muc [ 1 -1 -1 0 0 0 0 ] 0.00178; - -plasticViscosityCoeff plasticViscosityCoeff [ 1 -1 -1 0 0 0 0 ] 0.00023143; - -plasticViscosityExponent plasticViscosityExponent [ 0 0 0 0 0 0 0 ] 0.17926; - -BinghamPlastic on; - -yieldStressCoeff yieldStressCoeff [ 1 -1 -2 0 0 0 0 ] 5.5469e-07; - -yieldStressExponent yieldStressExponent [ 0 0 0 0 0 0 0 ] 95.25; - -yieldStressOffset yieldStressOffset [ 0 0 0 0 0 0 0 ] 0; - -muMax muMax [ 1 -1 -1 0 0 0 0 ] 10.0; - -rhoc rhoc [ 1 -3 0 0 0 0 0 ] 1000; - -rhod rhod [ 1 -3 0 0 0 0 0 ] 1042; - -VdjModel simple; - -simpleCoeffs -{ - V0 V0 [ 0 1 -1 0 0 0 0 ] ( 0 -0.002198 0 ); - a a [ 0 0 0 0 0 0 0 ] 8.84; - a1 a1 [ 0 0 0 0 0 0 0 ] 0; - alphaMin alphaMin [ 0 0 0 0 0 0 0 ] 0; -} - -generalCoeffs -{ - V0 V0 [ 0 1 -1 0 0 0 0 ] ( 0 -0.0018 0 ); - a a [ 0 0 0 0 0 0 0 ] 1e-05; - a1 a1 [ 0 0 0 0 0 0 0 ] 0.1; - alphaMin alphaMin [ 0 0 0 0 0 0 0 ] 2e-05; -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/system/controlDict b/tutorials/multiphase/settlingFoam/ras/tank3D/system/controlDict deleted file mode 100644 index c82874f097..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/system/controlDict +++ /dev/null @@ -1,48 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object controlDict; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -application settlingFoam; - -startFrom startTime; - -startTime 0; - -stopAt endTime; - -endTime 8000; - -deltaT 0.1; - -writeControl runTime; - -writeInterval 50; - -purgeWrite 0; - -writeFormat ascii; - -writePrecision 6; - -writeCompression compressed; - -timeFormat general; - -timePrecision 6; - -runTimeModifiable yes; - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/system/fvSchemes b/tutorials/multiphase/settlingFoam/ras/tank3D/system/fvSchemes deleted file mode 100644 index 6adb2cc47d..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/system/fvSchemes +++ /dev/null @@ -1,61 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / A nd | Web: www.OpenFOAM.org | -| \\/ M anipulation | | -\*---------------------------------------------------------------------------*/ -FoamFile -{ - version 2.0; - format ascii; - class dictionary; - location "system"; - object fvSchemes; -} -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -ddtSchemes -{ - default Euler; -} - -gradSchemes -{ - default Gauss linear; -} - -divSchemes -{ - default none; - - div(phi,U) Gauss limitedLinearV 1; - div(phi,k) Gauss limitedLinear 1; - div(phi,epsilon) Gauss limitedLinear 1; - div(phiAlpha,Alpha) Gauss limitedLinear01 1; - div(phiVdj,Vdj) Gauss linear; -} - -laplacianSchemes -{ - default Gauss linear corrected; -} - -interpolationSchemes -{ - default linear; -} - -snGradSchemes -{ - default corrected; -} - -fluxRequired -{ - default no; - p_rgh ; -} - - -// ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/system/fvSolution b/tutorials/multiphase/settlingFoam/ras/tank3D/system/fvSolution deleted file mode 100644 index d52dacb0e5..0000000000 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/system/fvSolution +++ /dev/null @@ -1,87 +0,0 @@ -/*--------------------------------*- C++ -*----------------------------------*\ -| ========= | | -| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 2.3.0 | -| \\ / 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-07; - relTol 0.01; - } - - p_rghFinal - { - $p_rgh; - tolerance 1e-07; - relTol 0; - } - - "(U|Alpha|k|epsilon)" - { - solver smoothSolver; - smoother symGaussSeidel; - tolerance 1e-07; - relTol 0.1; - } - - "(U|Alpha|k|epsilon)Final" - { - $k; - tolerance 1e-07; - relTol 0; - } - - rho - { - solver PCG; - preconditioner DIC; - tolerance 1e-07; - relTol 0.1; - } - - rhoFinal - { - $rho; - tolerance 1e-07; - relTol 0; - } -} - -PIMPLE -{ - nCorrectors 2; - nNonOrthogonalCorrectors 0; -} - -relaxationFactors -{ - fields - { - } - equations - { - "Alpha.*" 1; - "U.*" 1; - "k.*" 1; - "epsilon.*" 1; - } -} - - -// ************************************************************************* //