diff --git a/applications/solvers/multiphase/cavitatingFoam/alphavPsi.H b/applications/solvers/multiphase/cavitatingFoam/alphavPsi.H new file mode 100644 index 0000000000..ed799ae4b4 --- /dev/null +++ b/applications/solvers/multiphase/cavitatingFoam/alphavPsi.H @@ -0,0 +1,20 @@ +{ + alphav = + max + ( + min + ( + (rho - rholSat)/(rhovSat - rholSat), + scalar(1) + ), + scalar(0) + ); + alphal = 1.0 - alphav; + + Info<< "max-min alphav: " << max(alphav).value() + << " " << min(alphav).value() << endl; + + psiModel->correct(); + + //Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl; +} diff --git a/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/cavitatingDyMFoam.C b/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/cavitatingDyMFoam.C index cf608d0a6a..2dca530c14 100644 --- a/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/cavitatingDyMFoam.C +++ b/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/cavitatingDyMFoam.C @@ -101,7 +101,7 @@ int main(int argc, char *argv[]) while (pimple.loop()) { #include "rhoEqn.H" - #include "gammaPsi.H" + #include "alphavPsi.H" #include "UEqn.H" // --- Pressure corrector loop diff --git a/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/pEqn.H b/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/pEqn.H index 3c4cbb0d32..5ad7fdeb66 100644 --- a/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/pEqn.H +++ b/applications/solvers/multiphase/cavitatingFoam/cavitatingDyMFoam/pEqn.H @@ -4,8 +4,8 @@ p = ( rho - - gamma2*rhol0 - - ((gamma*psiv + gamma2*psil) - psi)*pSat + - alphal*rhol0 + - ((alphav*psiv + alphal*psil) - psi)*pSat )/psi; } @@ -52,13 +52,13 @@ rho == max(rho0 + psi*p, rhoMin); - #include "gammaPsi.H" + #include "alphavPsi.H" p = ( rho - - gamma2*rhol0 - - ((gamma*psiv + gamma2*psil) - psi)*pSat + - alphal*rhol0 + - ((alphav*psiv + alphal*psil) - psi)*pSat )/psi; p.correctBoundaryConditions(); diff --git a/applications/solvers/multiphase/cavitatingFoam/cavitatingFoam.C b/applications/solvers/multiphase/cavitatingFoam/cavitatingFoam.C index 73e9577029..c4453df391 100644 --- a/applications/solvers/multiphase/cavitatingFoam/cavitatingFoam.C +++ b/applications/solvers/multiphase/cavitatingFoam/cavitatingFoam.C @@ -72,7 +72,7 @@ int main(int argc, char *argv[]) while (pimple.loop()) { #include "rhoEqn.H" - #include "gammaPsi.H" + #include "alphavPsi.H" #include "UEqn.H" // --- Pressure corrector loop diff --git a/applications/solvers/multiphase/cavitatingFoam/continuityErrs.H b/applications/solvers/multiphase/cavitatingFoam/continuityErrs.H index ce618ee40f..14b0ef7786 100644 --- a/applications/solvers/multiphase/cavitatingFoam/continuityErrs.H +++ b/applications/solvers/multiphase/cavitatingFoam/continuityErrs.H @@ -1,5 +1,5 @@ { - volScalarField thermoRho = psi*p + gamma2*rhol0; + volScalarField thermoRho = psi*p + alphal*rhol0; dimensionedScalar totalMass = fvc::domainIntegrate(rho); diff --git a/applications/solvers/multiphase/cavitatingFoam/createFields.H b/applications/solvers/multiphase/cavitatingFoam/createFields.H index 8958dc3c5e..605c0deece 100644 --- a/applications/solvers/multiphase/cavitatingFoam/createFields.H +++ b/applications/solvers/multiphase/cavitatingFoam/createFields.H @@ -44,19 +44,19 @@ Info<< "Reading transportProperties\n" << endl; - incompressibleTwoPhaseMixture twoPhaseProperties(U, phiv, "gamma"); + incompressibleTwoPhaseMixture twoPhaseProperties(U, phiv); - volScalarField& gamma(twoPhaseProperties.alpha1()); - gamma.oldTime(); + volScalarField& alphav(twoPhaseProperties.alpha1()); + alphav.oldTime(); - volScalarField& gamma2(twoPhaseProperties.alpha2()); + volScalarField& alphal(twoPhaseProperties.alpha2()); Info<< "Creating compressibilityModel\n" << endl; autoPtr psiModel = barotropicCompressibilityModel::New ( thermodynamicProperties, - gamma + alphav ); const volScalarField& psi = psiModel->psi(); @@ -64,8 +64,8 @@ rho == max ( psi*p - + gamma2*rhol0 - + ((gamma*psiv + gamma2*psil) - psi)*pSat, + + alphal*rhol0 + + ((alphav*psiv + alphal*psil) - psi)*pSat, rhoMin ); diff --git a/applications/solvers/multiphase/cavitatingFoam/gammaPsi.H b/applications/solvers/multiphase/cavitatingFoam/gammaPsi.H deleted file mode 100644 index 4edda7336d..0000000000 --- a/applications/solvers/multiphase/cavitatingFoam/gammaPsi.H +++ /dev/null @@ -1,11 +0,0 @@ -{ - gamma = max(min((rho - rholSat)/(rhovSat - rholSat), scalar(1)), scalar(0)); - gamma2 = 1.0 - gamma; - - Info<< "max-min gamma: " << max(gamma).value() - << " " << min(gamma).value() << endl; - - psiModel->correct(); - - //Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl; -} diff --git a/applications/solvers/multiphase/cavitatingFoam/pEqn.H b/applications/solvers/multiphase/cavitatingFoam/pEqn.H index b2c7d953b5..da43e67ce7 100644 --- a/applications/solvers/multiphase/cavitatingFoam/pEqn.H +++ b/applications/solvers/multiphase/cavitatingFoam/pEqn.H @@ -4,8 +4,8 @@ p = ( rho - - gamma2*rhol0 - - ((gamma*psiv + gamma2*psil) - psi)*pSat + - alphal*rhol0 + - ((alphav*psiv + alphal*psil) - psi)*pSat )/psi; } @@ -29,7 +29,7 @@ fvScalarMatrix pEqn ( fvm::ddt(psi, p) - - (rhol0 + (psil - psiv)*pSat)*fvc::ddt(gamma) - pSat*fvc::ddt(psi) + - (rhol0 + (psil - psiv)*pSat)*fvc::ddt(alphav) - pSat*fvc::ddt(psi) + fvc::div(phiv, rho) + fvc::div(phiGradp) - fvm::laplacian(rAUf, p) @@ -49,18 +49,18 @@ rho == max ( psi*p - + gamma2*rhol0 - + ((gamma*psiv + gamma2*psil) - psi)*pSat, + + alphal*rhol0 + + ((alphav*psiv + alphal*psil) - psi)*pSat, rhoMin ); - #include "gammaPsi.H" + #include "alphavPsi.H" p = ( rho - - gamma2*rhol0 - - ((gamma*psiv + gamma2*psil) - psi)*pSat + - alphal*rhol0 + - ((alphav*psiv + alphal*psil) - psi)*pSat )/psi; p.correctBoundaryConditions(); diff --git a/applications/solvers/multiphase/compressibleInterFoam/twoPhaseMixtureThermo/twoPhaseMixtureThermo.C b/applications/solvers/multiphase/compressibleInterFoam/twoPhaseMixtureThermo/twoPhaseMixtureThermo.C index d81f5ccb1f..e9c5322c79 100644 --- a/applications/solvers/multiphase/compressibleInterFoam/twoPhaseMixtureThermo/twoPhaseMixtureThermo.C +++ b/applications/solvers/multiphase/compressibleInterFoam/twoPhaseMixtureThermo/twoPhaseMixtureThermo.C @@ -49,12 +49,12 @@ Foam::twoPhaseMixtureThermo::twoPhaseMixtureThermo thermo2_(NULL) { { - volScalarField T1("T" + phase1Name(), T_); + volScalarField T1(IOobject::groupName("T", phase1Name()), T_); T1.write(); } { - volScalarField T2("T" + phase2Name(), T_); + volScalarField T2(IOobject::groupName("T", phase2Name()), T_); T2.write(); } diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Allwclean b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Allwclean deleted file mode 100755 index 8af1402435..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Allwclean +++ /dev/null @@ -1,10 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory -set -x - -wclean libso twoPhaseSystem -wclean libso interfacialModels -wclean libso phaseIncompressibleTurbulenceModels -wclean - -# ----------------------------------------------------------------- end-of-file diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Allwmake b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Allwmake deleted file mode 100755 index 6ba04af789..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Allwmake +++ /dev/null @@ -1,11 +0,0 @@ -#!/bin/sh -cd ${0%/*} || exit 1 # run from this directory -set -x - -wmakeLnInclude interfacialModels -wmake libso twoPhaseSystem -wmake libso interfacialModels -wmake libso phaseIncompressibleTurbulenceModels -wmake - -# ----------------------------------------------------------------- end-of-file diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/CourantNos.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/CourantNos.H deleted file mode 100644 index 4433c5cde4..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/CourantNos.H +++ /dev/null @@ -1,12 +0,0 @@ -# include "CourantNo.H" - -{ - scalar UrCoNum = 0.5*gMax - ( - fvc::surfaceSum(mag(phi1 - phi2))().internalField()/mesh.V().field() - )*runTime.deltaTValue(); - - Info<< "Max Ur Courant Number = " << UrCoNum << endl; - - CoNum = max(CoNum, UrCoNum); -} diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/DDtU.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/DDtU.H deleted file mode 100644 index 1685caa588..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/DDtU.H +++ /dev/null @@ -1,13 +0,0 @@ -{ - DDtU1 = - fvc::ddt(U1) - + fvc::div(phi1, U1) - - fvc::div(phi1)*U1; - mrfZones.addCoriolis(U1, DDtU1); - - DDtU2 = - fvc::ddt(U2) - + fvc::div(phi2, U2) - - fvc::div(phi2)*U2; - mrfZones.addCoriolis(U2, DDtU2); -} diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Make/files b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Make/files deleted file mode 100644 index 8a3ad43683..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -compressibleTwoPhaseEulerFoam.C - -EXE = $(FOAM_APPBIN)/compressibleTwoPhaseEulerFoam diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Make/options b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Make/options deleted file mode 100644 index e178081548..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/Make/options +++ /dev/null @@ -1,23 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/transportModels/incompressible/lnInclude \ - -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \ - -I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \ - -I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude \ - -IphaseIncompressibleTurbulenceModels/lnInclude \ - -IinterfacialModels/lnInclude \ - -ItwoPhaseSystem/lnInclude \ - -Iaveraging - -EXE_LIBS = \ - -lfluidThermophysicalModels \ - -lspecie \ - -lturbulenceModels \ - -lincompressibleTurbulenceModels \ - -lphaseIncompressibleTurbulenceModels \ - -lincompressibleTransportModels \ - -lcompressibleTwoPhaseSystem \ - -lcompressibleEulerianInterfacialModels \ - -lfiniteVolume \ - -lmeshTools diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/UEqns.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/UEqns.H deleted file mode 100644 index dea48be335..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/UEqns.H +++ /dev/null @@ -1,61 +0,0 @@ -mrfZones.correctBoundaryVelocity(U1); -mrfZones.correctBoundaryVelocity(U2); -mrfZones.correctBoundaryVelocity(U); - -fvVectorMatrix U1Eqn(U1, U1.dimensions()*dimVol/dimTime); -fvVectorMatrix U2Eqn(U2, U2.dimensions()*dimVol/dimTime); - -volScalarField dragCoeff(fluid.dragCoeff()); - -{ - volVectorField liftForce(fluid.liftForce(U)); - - { - U1Eqn = - ( - fvm::ddt(alpha1, U1) - + fvm::div(alphaPhi1, U1) - - // Compressibity correction - - fvm::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), U1) - - + fluid.Cvm()*rho2*alpha1*alpha2/rho1* - ( - fvm::ddt(U1) - + fvm::div(phi1, U1) - - fvm::Sp(fvc::div(phi1), U1) - ) - - + turbulence1->divDevReff(U1) - == - - fvm::Sp(dragCoeff/rho1, U1) - - alpha1*alpha2/rho1*(liftForce - fluid.Cvm()*rho2*DDtU2) - ); - mrfZones.addCoriolis(alpha1*(1 + fluid.Cvm()*rho2*alpha2/rho1), U1Eqn); - U1Eqn.relax(); - } - - { - U2Eqn = - ( - fvm::ddt(alpha2, U2) - + fvm::div(alphaPhi2, U2) - - // Compressibity correction - - fvm::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), U2) - - + fluid.Cvm()*rho2*alpha1*alpha2/rho2* - ( - fvm::ddt(U2) - + fvm::div(phi2, U2) - - fvm::Sp(fvc::div(phi2), U2) - ) - + turbulence2->divDevReff(U2) - == - - fvm::Sp(dragCoeff/rho2, U2) - + alpha1*alpha2/rho2*(liftForce + fluid.Cvm()*rho2*DDtU1) - ); - mrfZones.addCoriolis(alpha2*(1 + fluid.Cvm()*rho2*alpha1/rho2), U2Eqn); - U2Eqn.relax(); - } -} diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/alphaEqn.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/alphaEqn.H deleted file mode 100644 index 77a04592e3..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/alphaEqn.H +++ /dev/null @@ -1,142 +0,0 @@ -{ - word alphaScheme("div(phi," + alpha1.name() + ')'); - word alpharScheme("div(phir," + alpha1.name() + ')'); - - surfaceScalarField phic("phic", phi); - surfaceScalarField phir("phir", phi1 - phi2); - - surfaceScalarField alpha1f(fvc::interpolate(max(alpha1, scalar(0)))); - - tmp pPrimeByA; - - if (implicitPhasePressure) - { - pPrimeByA = - fvc::interpolate((1.0/rho1)*rAU1*turbulence1().pPrime()) - + fvc::interpolate((1.0/rho2)*rAU2*turbulence2().pPrime()); - - surfaceScalarField phiP - ( - pPrimeByA()*fvc::snGrad(alpha1, "bounded")*mesh.magSf() - ); - - phic += alpha1f*phiP; - phir += phiP; - } - - for (int acorr=0; acorr 0.0 && alpha1[celli] > 0.0) - { - Sp[celli] -= dgdt[celli]*alpha1[celli]; - Su[celli] += dgdt[celli]*alpha1[celli]; - } - else if (dgdt[celli] < 0.0 && alpha1[celli] < 1.0) - { - Sp[celli] += dgdt[celli]*(1.0 - alpha1[celli]); - } - } - - dimensionedScalar totalDeltaT = runTime.deltaT(); - if (nAlphaSubCycles > 1) - { - alphaPhi1 = dimensionedScalar("0", alphaPhi1.dimensions(), 0); - } - - for - ( - subCycle alphaSubCycle(alpha1, nAlphaSubCycles); - !(++alphaSubCycle).end(); - ) - { - surfaceScalarField alphaPhic1 - ( - fvc::flux - ( - phic, - alpha1, - alphaScheme - ) - + fvc::flux - ( - -fvc::flux(-phir, scalar(1) - alpha1, alpharScheme), - alpha1, - alpharScheme - ) - ); - - MULES::explicitSolve - ( - geometricOneField(), - alpha1, - phi, - alphaPhic1, - Sp, - Su, - 1, - 0 - ); - - if (nAlphaSubCycles > 1) - { - alphaPhi1 += (runTime.deltaT()/totalDeltaT)*alphaPhic1; - } - else - { - alphaPhi1 = alphaPhic1; - } - } - - if (implicitPhasePressure) - { - fvScalarMatrix alpha1Eqn - ( - fvm::ddt(alpha1) - fvc::ddt(alpha1) - - fvm::laplacian(alpha1f*pPrimeByA, alpha1, "bounded") - ); - - alpha1Eqn.relax(); - alpha1Eqn.solve(); - - alphaPhi1 += alpha1Eqn.flux(); - } - - alphaPhi2 = phi - alphaPhi1; - alpha2 = scalar(1) - alpha1; - - Info<< "Dispersed phase volume fraction = " - << alpha1.weightedAverage(mesh.V()).value() - << " Min(alpha1) = " << min(alpha1).value() - << " Max(alpha1) = " << max(alpha1).value() - << endl; - } -} - -rho = fluid.rho(); diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/compressibleTwoPhaseEulerFoam.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/compressibleTwoPhaseEulerFoam.C deleted file mode 100644 index 22018f9d8c..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/compressibleTwoPhaseEulerFoam.C +++ /dev/null @@ -1,110 +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 - compressibleTwoPhaseEulerFoam - -Description - Solver for a system of 2 compressible fluid phases with one phase - dispersed, e.g. gas bubbles in a liquid including heat-transfer. - -\*---------------------------------------------------------------------------*/ - -#include "fvCFD.H" -#include "MULES.H" -#include "subCycle.H" -#include "rhoThermo.H" -#include "twoPhaseSystem.H" -#include "dragModel.H" -#include "heatTransferModel.H" -#include "PhaseIncompressibleTurbulenceModel.H" -#include "pimpleControl.H" -#include "IOMRFZoneList.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -int main(int argc, char *argv[]) -{ - #include "setRootCase.H" - - #include "createTime.H" - #include "createMesh.H" - #include "readGravitationalAcceleration.H" - #include "createFields.H" - #include "createMRFZones.H" - #include "initContinuityErrs.H" - #include "readTimeControls.H" - #include "CourantNos.H" - #include "setInitialDeltaT.H" - - pimpleControl pimple(mesh); - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - Info<< "\nStarting time loop\n" << endl; - - while (runTime.run()) - { - #include "readTwoPhaseEulerFoamControls.H" - #include "CourantNos.H" - #include "setDeltaT.H" - - runTime++; - Info<< "Time = " << runTime.timeName() << nl << endl; - - // --- Pressure-velocity PIMPLE corrector loop - while (pimple.loop()) - { - #include "alphaEqn.H" - #include "EEqns.H" - #include "UEqns.H" - - // --- Pressure corrector loop - while (pimple.correct()) - { - #include "pEqn.H" - } - - #include "DDtU.H" - - if (pimple.turbCorr()) - { - turbulence1->correct(); - turbulence2->correct(); - } - } - - #include "write.H" - - Info<< "ExecutionTime = " - << runTime.elapsedCpuTime() - << " s\n\n" << endl; - } - - Info<< "End\n" << endl; - - return 0; -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/createFields.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/createFields.H deleted file mode 100644 index f279445cf6..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/createFields.H +++ /dev/null @@ -1,185 +0,0 @@ - Info<< "Creating twoPhaseSystem\n" << endl; - - twoPhaseSystem fluid(mesh); - - phaseModel& phase1 = fluid.phase1(); - phaseModel& phase2 = fluid.phase2(); - - volScalarField& alpha1 = phase1; - volScalarField& alpha2 = phase2; - - volVectorField& U1 = phase1.U(); - surfaceScalarField& phi1 = phase1.phi(); - surfaceScalarField alphaPhi1 - ( - IOobject::groupName("alphaPhi", phase1.name()), - fvc::interpolate(alpha1)*phi1 - ); - - volVectorField& U2 = phase2.U(); - surfaceScalarField& phi2 = phase2.phi(); - surfaceScalarField alphaPhi2 - ( - IOobject::groupName("alphaPhi", phase2.name()), - fvc::interpolate(alpha2)*phi2 - ); - - dimensionedScalar pMin - ( - "pMin", - dimPressure, - fluid.lookup("pMin") - ); - - rhoThermo& thermo1 = phase1.thermo(); - rhoThermo& thermo2 = phase2.thermo(); - - volScalarField& p = thermo1.p(); - - volScalarField& rho1 = thermo1.rho(); - const volScalarField& psi1 = thermo1.psi(); - - volScalarField& rho2 = thermo2.rho(); - const volScalarField& psi2 = thermo2.psi(); - - volVectorField U - ( - IOobject - ( - "U", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - fluid.U() - ); - - surfaceScalarField phi - ( - IOobject - ( - "phi", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - fluid.phi() - ); - - volScalarField rho - ( - IOobject - ( - "rho", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - fluid.rho() - ); - - Info<< "Calculating field DDtU1 and DDtU2\n" << endl; - - volVectorField DDtU1 - ( - fvc::ddt(U1) - + fvc::div(phi1, U1) - - fvc::div(phi1)*U1 - ); - - volVectorField DDtU2 - ( - fvc::ddt(U2) - + fvc::div(phi2, U2) - - fvc::div(phi2)*U2 - ); - - - Info<< "Calculating field g.h\n" << endl; - volScalarField gh("gh", g & mesh.C()); - - volScalarField rAU1 - ( - IOobject - ( - IOobject::groupName("rAU", phase1.name()), - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::NO_WRITE - ), - mesh, - dimensionedScalar("zero", dimensionSet(0, 0, 1, 0, 0), 0.0) - ); - - volScalarField rAU2 - ( - IOobject - ( - IOobject::groupName("rAU", phase2.name()), - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::NO_WRITE - ), - mesh, - dimensionedScalar("zero", dimensionSet(0, 0, 1, 0, 0), 0.0) - ); - - label pRefCell = 0; - scalar pRefValue = 0.0; - setRefCell(p, mesh.solutionDict().subDict("PIMPLE"), pRefCell, pRefValue); - - - volScalarField dgdt - ( - pos(alpha2)*fvc::div(phi)/max(alpha2, scalar(0.0001)) - ); - - - Info<< "Creating field dpdt\n" << endl; - volScalarField dpdt - ( - IOobject - ( - "dpdt", - runTime.timeName(), - mesh - ), - mesh, - dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) - ); - - - Info<< "Creating field kinetic energy K\n" << endl; - volScalarField K1(IOobject::groupName("K", phase1.name()), 0.5*magSqr(U1)); - volScalarField K2(IOobject::groupName("K", phase2.name()), 0.5*magSqr(U2)); - - autoPtr > - turbulence1 - ( - PhaseIncompressibleTurbulenceModel::New - ( - alpha1, - U1, - alphaPhi1, - phi1, - phase1 - ) - ); - - autoPtr > - turbulence2 - ( - PhaseIncompressibleTurbulenceModel::New - ( - alpha2, - U2, - alphaPhi2, - phi2, - phase2 - ) - ); diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/createMRFZones.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/createMRFZones.H deleted file mode 100644 index 7b875a20e0..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/createMRFZones.H +++ /dev/null @@ -1,4 +0,0 @@ - IOMRFZoneList mrfZones(mesh); - mrfZones.correctBoundaryVelocity(U1); - mrfZones.correctBoundaryVelocity(U2); - mrfZones.correctBoundaryVelocity(U); diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/Make/files b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/Make/files deleted file mode 100644 index 43c0f9b2a9..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/Make/files +++ /dev/null @@ -1,15 +0,0 @@ -dragModels/dragModel/dragModel.C -dragModels/dragModel/newDragModel.C -dragModels/Ergun/Ergun.C -dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C -dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C -dragModels/SchillerNaumann/SchillerNaumann.C -dragModels/Gibilaro/Gibilaro.C -dragModels/WenYu/WenYu.C -dragModels/SyamlalOBrien/SyamlalOBrien.C - -heatTransferModels/heatTransferModel/heatTransferModel.C -heatTransferModels/heatTransferModel/newHeatTransferModel.C -heatTransferModels/RanzMarshall/RanzMarshall.C - -LIB = $(FOAM_LIBBIN)/libcompressibleEulerianInterfacialModels diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/Make/options b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/Make/options deleted file mode 100644 index e7e60696ec..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/Make/options +++ /dev/null @@ -1,10 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ - -I$(LIB_SRC)/transportModels/incompressible/transportModel \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I../twoPhaseSystem/lnInclude - -LIB_LIBS = \ - -lcompressibleTwoPhaseSystem \ - -lfluidThermophysicalModels \ - -lspecie diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.C deleted file mode 100644 index 5d07ed2168..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.C +++ /dev/null @@ -1,83 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "Ergun.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - defineTypeNameAndDebug(Ergun, 0); - - addToRunTimeSelectionTable - ( - dragModel, - Ergun, - dictionary - ); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModels::Ergun::Ergun -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - dragModel(interfaceDict, alpha1, phase1, phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModels::Ergun::~Ergun() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::dragModels::Ergun::K -( - const volScalarField& Ur -) const -{ - volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1.0e-6))); - - return - 150.0*alpha1_*phase2_.nu()*phase2_.rho() - /sqr(alpha2*phase1_.d()) - + 1.75*phase2_.rho()*Ur/(alpha2*phase1_.d()); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.H deleted file mode 100644 index 558b668884..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.H +++ /dev/null @@ -1,96 +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 . - -Class - Foam::dragModels::Ergun - -Description - H, Enwald, E. Peirano, A-E Almstedt - 'Eulerian Two-Phase Flow Theory Applied to Fluidization' - Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) - Eq. 104, p. 42 - -SourceFiles - Ergun.C - -\*---------------------------------------------------------------------------*/ - -#ifndef Ergun_H -#define Ergun_H - -#include "dragModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - -/*---------------------------------------------------------------------------*\ - Class Ergun Declaration -\*---------------------------------------------------------------------------*/ - -class Ergun -: - public dragModel -{ - -public: - - //- Runtime type information - TypeName("Ergun"); - - - // Constructors - - //- Construct from components - Ergun - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - //- Destructor - virtual ~Ergun(); - - - // Member Functions - - tmp K(const volScalarField& Ur) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace dragModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.C deleted file mode 100644 index c500b5b959..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.C +++ /dev/null @@ -1,82 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "Gibilaro.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - defineTypeNameAndDebug(Gibilaro, 0); - - addToRunTimeSelectionTable - ( - dragModel, - Gibilaro, - dictionary - ); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModels::Gibilaro::Gibilaro -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - dragModel(interfaceDict, alpha1, phase1, phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModels::Gibilaro::~Gibilaro() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::dragModels::Gibilaro::K -( - const volScalarField& Ur -) const -{ - volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1.0e-6))); - volScalarField bp(pow(alpha2, -2.8)); - volScalarField Re(max(alpha2*Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); - - return (17.3/Re + scalar(0.336))*phase2_.rho()*Ur*bp/phase1_.d(); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.H deleted file mode 100644 index 48c714ee4e..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.H +++ /dev/null @@ -1,96 +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 . - -Class - Foam::dragModels::Gibilaro - -Description - H, Enwald, E. Peirano, A-E Almstedt - 'Eulerian Two-Phase Flow Theory Applied to Fluidization' - Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) - Eq. 106, p. 43 - -SourceFiles - Gibilaro.C - -\*---------------------------------------------------------------------------*/ - -#ifndef Gibilaro_H -#define Gibilaro_H - -#include "dragModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - -/*---------------------------------------------------------------------------*\ - Class Gibilaro Declaration -\*---------------------------------------------------------------------------*/ - -class Gibilaro -: - public dragModel -{ - -public: - - //- Runtime type information - TypeName("Gibilaro"); - - - // Constructors - - //- Construct from components - Gibilaro - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - //- Destructor - virtual ~Gibilaro(); - - - // Member Functions - - tmp K(const volScalarField& Ur) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace dragModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C deleted file mode 100644 index 4fb9a62806..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C +++ /dev/null @@ -1,99 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "GidaspowErgunWenYu.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - defineTypeNameAndDebug(GidaspowErgunWenYu, 0); - - addToRunTimeSelectionTable - ( - dragModel, - GidaspowErgunWenYu, - dictionary - ); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModels::GidaspowErgunWenYu::GidaspowErgunWenYu -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - dragModel(interfaceDict, alpha1, phase1, phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModels::GidaspowErgunWenYu::~GidaspowErgunWenYu() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::dragModels::GidaspowErgunWenYu::K -( - const volScalarField& Ur -) const -{ - volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1.0e-6))); - volScalarField d(phase1_.d()); - volScalarField bp(pow(alpha2, -2.65)); - volScalarField Re(max(Ur*d/phase2_.nu(), scalar(1.0e-3))); - - volScalarField Cds - ( - neg(Re - 1000)*(24.0*(1.0 + 0.15*pow(Re, 0.687))/Re) - + pos(Re - 1000)*0.44 - ); - - // Wen and Yu (1966) - return - ( - pos(alpha2 - 0.8) - *(0.75*Cds*phase2_.rho()*Ur*bp/d) - + neg(alpha2 - 0.8) - *( - 150.0*alpha1_*phase2_.nu()*phase2_.rho()/(sqr(alpha2*d)) - + 1.75*phase2_.rho()*Ur/(alpha2*d) - ) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.H deleted file mode 100644 index f92c55f164..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.H +++ /dev/null @@ -1,94 +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 . - -Class - Foam::dragModels::GidaspowErgunWenYu - -Description - D. Gidaspow, Multiphase flow and fluidization, - Academic Press, New York, 1994. - -SourceFiles - GidaspowErgunWenYu.C - -\*---------------------------------------------------------------------------*/ - -#ifndef GidaspowErgunWenYu_H -#define GidaspowErgunWenYu_H - -#include "dragModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - -/*---------------------------------------------------------------------------*\ - Class GidaspowErgunWenYu Declaration -\*---------------------------------------------------------------------------*/ - -class GidaspowErgunWenYu -: - public dragModel -{ - -public: - - //- Runtime type information - TypeName("GidaspowErgunWenYu"); - - - // Constructors - - //- Construct from components - GidaspowErgunWenYu - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - //- Destructor - virtual ~GidaspowErgunWenYu(); - - - // Member Functions - - tmp K(const volScalarField& Ur) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace dragModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C deleted file mode 100644 index c3987a4fa3..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C +++ /dev/null @@ -1,88 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "GidaspowSchillerNaumann.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - defineTypeNameAndDebug(GidaspowSchillerNaumann, 0); - - addToRunTimeSelectionTable - ( - dragModel, - GidaspowSchillerNaumann, - dictionary - ); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModels::GidaspowSchillerNaumann::GidaspowSchillerNaumann -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - dragModel(interfaceDict, alpha1, phase1, phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModels::GidaspowSchillerNaumann::~GidaspowSchillerNaumann() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::dragModels::GidaspowSchillerNaumann::K -( - const volScalarField& Ur -) const -{ - volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1e-6))); - volScalarField bp(pow(alpha2, -2.65)); - - volScalarField Re(max(alpha2*Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); - volScalarField Cds - ( - neg(Re - 1000)*(24.0*(1.0 + 0.15*pow(Re, 0.687))/Re) - + pos(Re - 1000)*0.44 - ); - - return 0.75*Cds*phase2_.rho()*Ur*bp/phase1_.d(); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.H deleted file mode 100644 index a58b4ecb93..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.H +++ /dev/null @@ -1,103 +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 . - -Class - Foam::dragModels::GidaspowSchillerNaumann - -Description - H, Enwald, E. Peirano, A-E Almstedt - 'Eulerian Two-Phase Flow Theory Applied to Fluidization' - Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) - Eq. 86-87, p. 40 - - This is identical to the Wen and Yu, Rowe model Table 3.6 p.56 in - the Ph.D. thesis of Berend van Wachem - 'Derivation, Implementation and Validation - of - Computer Simulation Models - for Gas-Solid Fluidized Beds' - -SourceFiles - GidaspowSchillerNaumann.C - -\*---------------------------------------------------------------------------*/ - -#ifndef GidaspowSchillerNaumann_H -#define GidaspowSchillerNaumann_H - -#include "dragModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - -/*---------------------------------------------------------------------------*\ - Class GidaspowSchillerNaumann Declaration -\*---------------------------------------------------------------------------*/ - -class GidaspowSchillerNaumann -: - public dragModel -{ - -public: - - //- Runtime type information - TypeName("GidaspowSchillerNaumann"); - - - // Constructors - - //- Construct from components - GidaspowSchillerNaumann - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - //- Destructor - virtual ~GidaspowSchillerNaumann(); - - - // Member Functions - - tmp K(const volScalarField& Ur) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace dragModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.C deleted file mode 100644 index d8e8be31c6..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.C +++ /dev/null @@ -1,85 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "SchillerNaumann.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - defineTypeNameAndDebug(SchillerNaumann, 0); - - addToRunTimeSelectionTable - ( - dragModel, - SchillerNaumann, - dictionary - ); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModels::SchillerNaumann::SchillerNaumann -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - dragModel(interfaceDict, alpha1, phase1, phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModels::SchillerNaumann::~SchillerNaumann() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::dragModels::SchillerNaumann::K -( - const volScalarField& Ur -) const -{ - volScalarField Re(max(Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); - volScalarField Cds - ( - neg(Re - 1000)*(24.0*(1.0 + 0.15*pow(Re, 0.687))/Re) - + pos(Re - 1000)*0.44 - ); - - return 0.75*Cds*phase2_.rho()*Ur/phase1_.d(); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.C deleted file mode 100644 index 78cb907f45..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.C +++ /dev/null @@ -1,98 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "SyamlalOBrien.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - defineTypeNameAndDebug(SyamlalOBrien, 0); - - addToRunTimeSelectionTable - ( - dragModel, - SyamlalOBrien, - dictionary - ); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModels::SyamlalOBrien::SyamlalOBrien -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - dragModel(interfaceDict, alpha1, phase1, phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModels::SyamlalOBrien::~SyamlalOBrien() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::dragModels::SyamlalOBrien::K -( - const volScalarField& Ur -) const -{ - volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1.0e-6))); - volScalarField A(pow(alpha2, 4.14)); - volScalarField B - ( - neg(alpha2 - 0.85)*(0.8*pow(alpha2, 1.28)) - + pos(alpha2 - 0.85)*(pow(alpha2, 2.65)) - ); - - volScalarField Re(max(Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); - - volScalarField Vr - ( - 0.5* - ( - A - 0.06*Re + sqrt(sqr(0.06*Re) + 0.12*Re*(2.0*B - A) + sqr(A)) - ) - ); - - volScalarField Cds(sqr(0.63 + 4.8*sqrt(Vr/Re))); - - return 0.75*Cds*phase2_.rho()*Ur/(phase1_.d()*sqr(Vr)); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.H deleted file mode 100644 index e779a49443..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.H +++ /dev/null @@ -1,95 +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 . - -Class - Foam::dragModels::SyamlalOBrien - -Description - Syamlal, M., Rogers, W. and O'Brien, T. J. (1993) MFIX documentation, - Theory Guide. Technical Note DOE/METC-94/1004. Morgantown, West Virginia, - USA. - -SourceFiles - SyamlalOBrien.C - -\*---------------------------------------------------------------------------*/ - -#ifndef SyamlalOBrien_H -#define SyamlalOBrien_H - -#include "dragModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - -/*---------------------------------------------------------------------------*\ - Class SyamlalOBrien Declaration -\*---------------------------------------------------------------------------*/ - -class SyamlalOBrien -: - public dragModel -{ - -public: - - //- Runtime type information - TypeName("SyamlalOBrien"); - - - // Constructors - - //- Construct from components - SyamlalOBrien - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - //- Destructor - virtual ~SyamlalOBrien(); - - - // Member Functions - - tmp K(const volScalarField& Ur) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace dragModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.C deleted file mode 100644 index 60330f23b0..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.C +++ /dev/null @@ -1,88 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "WenYu.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - defineTypeNameAndDebug(WenYu, 0); - - addToRunTimeSelectionTable - ( - dragModel, - WenYu, - dictionary - ); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModels::WenYu::WenYu -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - dragModel(interfaceDict, alpha1, phase1, phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModels::WenYu::~WenYu() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::dragModels::WenYu::K -( - const volScalarField& Ur -) const -{ - volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1.0e-6))); - volScalarField bp(pow(alpha2, -2.65)); - - volScalarField Re(max(Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); - volScalarField Cds - ( - neg(Re - 1000)*(24.0*(1.0 + 0.15*pow(Re, 0.687))/Re) - + pos(Re - 1000)*0.44 - ); - - return 0.75*Cds*phase2_.rho()*Ur*bp/phase1_.d(); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.H deleted file mode 100644 index 3aa601ef04..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.H +++ /dev/null @@ -1,106 +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 . - -Class - Foam::dragModels::WenYu - -Description - H, Enwald, E. Peirano, A-E Almstedt - 'Eulerian Two-Phase Flow Theory Applied to Fluidization' - Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) - Eq. 86-87, p. 40 - - This is identical to the Wen and Yu, Rowe model Table 3.6 p.56 in - the Ph.D. thesis of Berend van Wachem - 'Derivation, Implementation and Validation - of - Computer Simulation Models - for Gas-Solid Fluidized Beds' - - NB: The difference between the Gidaspow-version is the void-fraction - in the Re-number - -SourceFiles - WenYu.C - -\*---------------------------------------------------------------------------*/ - -#ifndef WenYu_H -#define WenYu_H - -#include "dragModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace dragModels -{ - -/*---------------------------------------------------------------------------*\ - Class WenYu Declaration -\*---------------------------------------------------------------------------*/ - -class WenYu -: - public dragModel -{ - -public: - - //- Runtime type information - TypeName("WenYu"); - - - // Constructors - - //- Construct from components - WenYu - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - //- Destructor - virtual ~WenYu(); - - - // Member Functions - - tmp K(const volScalarField& Ur) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace dragModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.C deleted file mode 100644 index 0d2ed1c620..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.C +++ /dev/null @@ -1,60 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "dragModel.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(dragModel, 0); - defineRunTimeSelectionTable(dragModel, dictionary); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::dragModel::dragModel -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -: - interfaceDict_(interfaceDict), - alpha1_(alpha1), - phase1_(phase1), - phase2_(phase2) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::dragModel::~dragModel() -{} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.H deleted file mode 100644 index 54791695d5..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.H +++ /dev/null @@ -1,135 +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 . - -Class - Foam::dragModel - -Description - -SourceFiles - dragModel.C - newDragModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef dragModel_H -#define dragModel_H - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#include "dictionary.H" -#include "phaseModel.H" -#include "runTimeSelectionTables.H" - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class dragModel Declaration -\*---------------------------------------------------------------------------*/ - -class dragModel -{ -protected: - - // Protected data - - const dictionary& interfaceDict_; - const volScalarField& alpha1_; - const phaseModel& phase1_; - const phaseModel& phase2_; - - -public: - - //- Runtime type information - TypeName("dragModel"); - - - // Declare runtime construction - - declareRunTimeSelectionTable - ( - autoPtr, - dragModel, - dictionary, - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ), - (interfaceDict, alpha1, phase1, phase2) - ); - - - // Constructors - - dragModel - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - //- Destructor - virtual ~dragModel(); - - - // Selectors - - static autoPtr New - ( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 - ); - - - // Member Functions - - //- the dragfunction K used in the momentum eq. - // ddt(alpha1*rho1*U1) + ... = ... alpha1*alpha2*K*(U1-U2) - // ddt(alpha2*rho2*U2) + ... = ... alpha1*alpha2*K*(U2-U1) - // ********************************** NB! ***************************** - // for numerical reasons alpha1 and alpha2 has been - // extracted from the dragFunction K, - // so you MUST divide K by alpha1*alpha2 when implemnting the drag - // function - // ********************************** NB! ***************************** - virtual tmp K(const volScalarField& Ur) const = 0; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/newDragModel.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/newDragModel.C deleted file mode 100644 index 9159b28784..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/dragModels/dragModel/newDragModel.C +++ /dev/null @@ -1,65 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "dragModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -Foam::autoPtr Foam::dragModel::New -( - const dictionary& interfaceDict, - const volScalarField& alpha1, - const phaseModel& phase1, - const phaseModel& phase2 -) -{ - word dragModelType - ( - interfaceDict.lookup(phase1.name()) - ); - - Info << "Selecting dragModel for phase " - << phase1.name() - << ": " - << dragModelType << endl; - - dictionaryConstructorTable::iterator cstrIter = - dictionaryConstructorTablePtr_->find(dragModelType); - - if (cstrIter == dictionaryConstructorTablePtr_->end()) - { - FatalErrorIn("dragModel::New") - << "Unknown dragModelType type " - << dragModelType << endl << endl - << "Valid dragModel types are : " << endl - << dictionaryConstructorTablePtr_->sortedToc() - << exit(FatalError); - } - - return cstrIter()(interfaceDict, alpha1, phase1, phase2); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/pEqn.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/pEqn.H deleted file mode 100644 index e9211def7f..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/pEqn.H +++ /dev/null @@ -1,227 +0,0 @@ -{ - surfaceScalarField alpha1f(fvc::interpolate(alpha1)); - surfaceScalarField alpha2f(scalar(1) - alpha1f); - - rAU1 = 1.0/U1Eqn.A(); - rAU2 = 1.0/U2Eqn.A(); - - surfaceScalarField rAlphaAU1f(fvc::interpolate(alpha1*rAU1)); - surfaceScalarField rAlphaAU2f(fvc::interpolate(alpha2*rAU2)); - - volVectorField HbyA1 - ( - IOobject::groupName("HbyA", phase1.name()), - U1 - ); - HbyA1 = rAU1*U1Eqn.H(); - - volVectorField HbyA2 - ( - IOobject::groupName("HbyA", phase2.name()), - U2 - ); - HbyA2 = rAU2*U2Eqn.H(); - - mrfZones.absoluteFlux(phi1.oldTime()); - mrfZones.absoluteFlux(phi1); - mrfZones.absoluteFlux(phi2.oldTime()); - mrfZones.absoluteFlux(phi2); - - // Phase-1 pressure flux (e.g. due to particle-particle pressure) - surfaceScalarField phiP1 - ( - "phiP1", - fvc::interpolate((1.0/rho1)*rAU1*turbulence1().pPrime()) - *fvc::snGrad(alpha1)*mesh.magSf() - ); - - // Phase-2 pressure flux (e.g. due to particle-particle pressure) - surfaceScalarField phiP2 - ( - "phiP2", - fvc::interpolate((1.0/rho2)*rAU2*turbulence2().pPrime()) - *fvc::snGrad(alpha2)*mesh.magSf() - ); - - surfaceScalarField phiHbyA1 - ( - IOobject::groupName("phiHbyA", phase1.name()), - (fvc::interpolate(HbyA1) & mesh.Sf()) - + fvc::ddtPhiCorr(rAU1, alpha1, U1, phi1) - ); - - surfaceScalarField phiHbyA2 - ( - IOobject::groupName("phiHbyA", phase2.name()), - (fvc::interpolate(HbyA2) & mesh.Sf()) - + fvc::ddtPhiCorr(rAU2, alpha2, U2, phi2) - ); - - phi = alpha1f*phiHbyA1 + alpha2f*phiHbyA2; - mrfZones.relativeFlux(phi); - - phiHbyA1 += - ( - fvc::interpolate((1.0/rho1)*rAU1*dragCoeff)*phi2 - - phiP1 - + rAlphaAU1f*(g & mesh.Sf()) - ); - mrfZones.relativeFlux(phiHbyA1); - - phiHbyA2 += - ( - fvc::interpolate((1.0/rho2)*rAU2*dragCoeff)*phi1 - - phiP2 - + rAlphaAU2f*(g & mesh.Sf()) - ); - mrfZones.relativeFlux(phiHbyA2); - - mrfZones.relativeFlux(phi1.oldTime()); - mrfZones.relativeFlux(phi1); - mrfZones.relativeFlux(phi2.oldTime()); - mrfZones.relativeFlux(phi2); - - surfaceScalarField phiHbyA("phiHbyA", alpha1f*phiHbyA1 + alpha2f*phiHbyA2); - - HbyA1 += (1.0/rho1)*rAU1*dragCoeff*U2; - HbyA2 += (1.0/rho2)*rAU2*dragCoeff*U1; - - surfaceScalarField Dp - ( - "Dp", - mag - ( - alpha1f*rAlphaAU1f/fvc::interpolate(rho1) - + alpha2f*rAlphaAU2f/fvc::interpolate(rho2) - ) - ); - - tmp pEqnComp1; - tmp pEqnComp2; - - if (pimple.transonic()) - { - surfaceScalarField phid1 - ( - IOobject::groupName("phid", phase1.name()), - fvc::interpolate(psi1)*phi1 - ); - surfaceScalarField phid2 - ( - IOobject::groupName("phid", phase2.name()), - fvc::interpolate(psi2)*phi2 - ); - - pEqnComp1 = - fvc::ddt(rho1) - + fvc::div(phi1, rho1) - fvc::Sp(fvc::div(phi1), rho1) - + correction - ( - psi1*fvm::ddt(p) - + fvm::div(phid1, p) - fvm::Sp(fvc::div(phid1), p) - ); - deleteDemandDrivenData(pEqnComp1().faceFluxCorrectionPtr()); - pEqnComp1().relax(); - - pEqnComp2 = - fvc::ddt(rho2) - + fvc::div(phi2, rho2) - fvc::Sp(fvc::div(phi2), rho2) - + correction - ( - psi2*fvm::ddt(p) - + fvm::div(phid2, p) - fvm::Sp(fvc::div(phid2), p) - ); - deleteDemandDrivenData(pEqnComp2().faceFluxCorrectionPtr()); - pEqnComp2().relax(); - } - else - { - pEqnComp1 = - fvc::ddt(rho1) + psi1*correction(fvm::ddt(p)) - + fvc::div(phi1, rho1) - fvc::Sp(fvc::div(phi1), rho1); - - pEqnComp2 = - fvc::ddt(rho2) + psi2*correction(fvm::ddt(p)) - + fvc::div(phi2, rho2) - fvc::Sp(fvc::div(phi2), rho2); - } - - // Cache p prior to solve for density update - volScalarField p_0(p); - - while (pimple.correctNonOrthogonal()) - { - fvScalarMatrix pEqnIncomp - ( - fvc::div(phiHbyA) - - fvm::laplacian(Dp, p) - ); - - solve - ( - ( - (alpha1/rho1)*pEqnComp1() - + (alpha2/rho2)*pEqnComp2() - ) - + pEqnIncomp, - mesh.solver(p.select(pimple.finalInnerIter())) - ); - - if (pimple.finalNonOrthogonalIter()) - { - surfaceScalarField mSfGradp(pEqnIncomp.flux()/Dp); - - phi1 = phiHbyA1 + rAlphaAU1f*mSfGradp/fvc::interpolate(rho1); - phi2 = phiHbyA2 + rAlphaAU2f*mSfGradp/fvc::interpolate(rho2); - phi = alpha1f*phi1 + alpha2f*phi2; - - dgdt = - ( - pos(alpha2)*(pEqnComp2 & p)/rho2 - - pos(alpha1)*(pEqnComp1 & p)/rho1 - ); - - p.relax(); - mSfGradp = pEqnIncomp.flux()/Dp; - - U1 = HbyA1 - + fvc::reconstruct - ( - rAlphaAU1f - *( - (g & mesh.Sf()) - + mSfGradp/fvc::interpolate(rho1) - ) - - phiP1 - ); - U1.correctBoundaryConditions(); - - U2 = HbyA2 - + fvc::reconstruct - ( - rAlphaAU2f - *( - (g & mesh.Sf()) - + mSfGradp/fvc::interpolate(rho2) - ) - - phiP2 - ); - U2.correctBoundaryConditions(); - - U = fluid.U(); - } - } - - p = max(p, pMin); - - // Update densities from change in p - rho1 += psi1*(p - p_0); - rho2 += psi2*(p - p_0); - - K1 = 0.5*magSqr(U1); - K2 = 0.5*magSqr(U2); - - if (thermo1.dpdt() || thermo2.dpdt()) - { - dpdt = fvc::ddt(p); - } -} diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/newRadialModel.C b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/newRadialModel.C deleted file mode 100644 index aa79335145..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/newRadialModel.C +++ /dev/null @@ -1,60 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "radialModel.H" - -// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * // - -Foam::autoPtr -Foam::kineticTheoryModels::radialModel::New -( - const dictionary& dict -) -{ - word radialModelType(dict.lookup("radialModel")); - - Info<< "Selecting radialModel " - << radialModelType << endl; - - dictionaryConstructorTable::iterator cstrIter = - dictionaryConstructorTablePtr_->find(radialModelType); - - if (cstrIter == dictionaryConstructorTablePtr_->end()) - { - FatalError - << "radialModel::New(const dictionary&) : " << endl - << " unknown radialModelType type " - << radialModelType - << ", constructor not in hash table" << endl << endl - << " Valid radialModelType types are :" << endl; - Info<< dictionaryConstructorTablePtr_->sortedToc() - << abort(FatalError); - } - - return autoPtr(cstrIter()(dict)); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/readPPProperties.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/readPPProperties.H deleted file mode 100644 index 4f32564a48..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/readPPProperties.H +++ /dev/null @@ -1,31 +0,0 @@ - IOdictionary ppProperties - ( - IOobject - ( - "ppProperties", - runTime.constant(), - mesh, - IOobject::MUST_READ, - IOobject::NO_WRITE - ) - ); - - scalar preAlphaExp - ( - readScalar(ppProperties.lookup("preAlphaExp")) - ); - - scalar alphaMax - ( - readScalar(ppProperties.lookup("alphaMax")) - ); - - scalar expMax - ( - readScalar(ppProperties.lookup("expMax")) - ); - - dimensionedScalar g0 - ( - ppProperties.lookup("g0") - ); diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/readTwoPhaseEulerFoamControls.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/readTwoPhaseEulerFoamControls.H deleted file mode 100644 index 29353a8fa1..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/readTwoPhaseEulerFoamControls.H +++ /dev/null @@ -1,7 +0,0 @@ - #include "readTimeControls.H" - #include "alphaControls.H" - - Switch implicitPhasePressure - ( - alphaControls.lookupOrDefault("implicitPhasePressure", false) - ); diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/write.H b/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/write.H deleted file mode 100644 index 303661beb6..0000000000 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/write.H +++ /dev/null @@ -1,17 +0,0 @@ - if (runTime.outputTime()) - { - volVectorField Ur - ( - IOobject - ( - "Ur", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - U1 - U2 - ); - - runTime.write(); - } diff --git a/applications/solvers/multiphase/interFoam/interMixingFoam/createFields.H b/applications/solvers/multiphase/interFoam/interMixingFoam/createFields.H index a425d40e7f..196c82194c 100644 --- a/applications/solvers/multiphase/interFoam/interMixingFoam/createFields.H +++ b/applications/solvers/multiphase/interFoam/interMixingFoam/createFields.H @@ -12,53 +12,6 @@ mesh ); - Info<< "Reading field alpha1\n" << endl; - volScalarField alpha1 - ( - IOobject - ( - "alpha1", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - - Info<< "Reading field alpha2\n" << endl; - volScalarField alpha2 - ( - IOobject - ( - "alpha2", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - - Info<< "Reading field alpha3\n" << endl; - volScalarField alpha3 - ( - IOobject - ( - "alpha3", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); - - alpha3 == 1.0 - alpha1 - alpha2; - - Info<< "Reading field U\n" << endl; volVectorField U ( @@ -77,6 +30,10 @@ threePhaseMixture threePhaseProperties(U, phi); + volScalarField& alpha1(threePhaseProperties.alpha1()); + volScalarField& alpha2(threePhaseProperties.alpha2()); + volScalarField& alpha3(threePhaseProperties.alpha3()); + const dimensionedScalar& rho1 = threePhaseProperties.rho1(); const dimensionedScalar& rho2 = threePhaseProperties.rho2(); const dimensionedScalar& rho3 = threePhaseProperties.rho3(); diff --git a/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.C b/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.C index fbf1e10ce3..50494062d5 100644 --- a/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.C +++ b/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -62,9 +62,64 @@ Foam::threePhaseMixture::threePhaseMixture ) ), - phase1Name_("phase1"), - phase2Name_("phase2"), - phase3Name_("phase3"), + phase1Name_(wordList(lookup("phases"))[0]), + phase2Name_(wordList(lookup("phases"))[1]), + phase3Name_(wordList(lookup("phases"))[2]), + + alpha1_ + ( + IOobject + ( + IOobject::groupName("alpha", phase1Name_), + U.time().timeName(), + U.mesh(), + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + U.mesh() + ), + + alpha2_ + ( + IOobject + ( + IOobject::groupName("alpha", phase2Name_), + U.time().timeName(), + U.mesh(), + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + U.mesh() + ), + + alpha3_ + ( + IOobject + ( + IOobject::groupName("alpha", phase3Name_), + U.time().timeName(), + U.mesh(), + IOobject::MUST_READ, + IOobject::AUTO_WRITE + ), + U.mesh() + ), + + U_(U), + phi_(phi), + + nu_ + ( + IOobject + ( + "nu", + U.time().timeName(), + U.db() + ), + U.mesh(), + dimensionedScalar("nu", dimensionSet(0, 2, -1, 0, 0), 0), + calculatedFvPatchScalarField::typeName + ), nuModel1_ ( @@ -99,28 +154,9 @@ Foam::threePhaseMixture::threePhaseMixture rho1_(nuModel1_->viscosityProperties().lookup("rho")), rho2_(nuModel2_->viscosityProperties().lookup("rho")), - rho3_(nuModel3_->viscosityProperties().lookup("rho")), - - U_(U), - phi_(phi), - - alpha1_(U_.db().lookupObject ("alpha1")), - alpha2_(U_.db().lookupObject ("alpha2")), - alpha3_(U_.db().lookupObject ("alpha3")), - - nu_ - ( - IOobject - ( - "nu", - U_.time().timeName(), - U_.db() - ), - U_.mesh(), - dimensionedScalar("nu", dimensionSet(0, 2, -1, 0, 0), 0), - calculatedFvPatchScalarField::typeName - ) + rho3_(nuModel3_->viscosityProperties().lookup("rho")) { + alpha3_ == 1.0 - alpha1_ - alpha2_; calcNu(); } diff --git a/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.H b/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.H index 3c8b873983..16337521d3 100644 --- a/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.H +++ b/applications/solvers/multiphase/interFoam/interMixingFoam/incompressibleThreePhaseMixture/threePhaseMixture.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -60,6 +60,15 @@ class threePhaseMixture word phase2Name_; word phase3Name_; + volScalarField alpha1_; + volScalarField alpha2_; + volScalarField alpha3_; + + const volVectorField& U_; + const surfaceScalarField& phi_; + + volScalarField nu_; + autoPtr nuModel1_; autoPtr nuModel2_; autoPtr nuModel3_; @@ -68,15 +77,6 @@ class threePhaseMixture dimensionedScalar rho2_; dimensionedScalar rho3_; - const volVectorField& U_; - const surfaceScalarField& phi_; - - const volScalarField& alpha1_; - const volScalarField& alpha2_; - const volScalarField& alpha3_; - - volScalarField nu_; - // Private Member Functions @@ -103,22 +103,49 @@ public: // Member Functions - //- Return const-access to phase1 viscosityModel - const viscosityModel& nuModel1() const + const word phase1Name() const { - return nuModel1_(); + return phase1Name_; } - //- Return const-access to phase2 viscosityModel - const viscosityModel& nuModel2() const + const word phase2Name() const { - return nuModel2_(); + return phase2Name_; } - //- Return const-access to phase3 viscosityModel - const viscosityModel& nuModel3() const + const word phase3Name() const { - return nuModel3_(); + return phase3Name_; + } + + const volScalarField& alpha1() const + { + return alpha1_; + } + + volScalarField& alpha1() + { + return alpha1_; + } + + const volScalarField& alpha2() const + { + return alpha2_; + } + + volScalarField& alpha2() + { + return alpha2_; + } + + const volScalarField& alpha3() const + { + return alpha3_; + } + + volScalarField& alpha3() + { + return alpha3_; } //- Return const-access to phase1 density @@ -139,21 +166,6 @@ public: return rho3_; }; - const volScalarField& alpha1() const - { - return alpha1_; - } - - const volScalarField& alpha2() const - { - return alpha2_; - } - - const volScalarField& alpha3() const - { - return alpha3_; - } - //- Return the velocity const volVectorField& U() const { @@ -166,6 +178,24 @@ public: return phi_; } + //- Return const-access to phase1 viscosityModel + const viscosityModel& nuModel1() const + { + return nuModel1_(); + } + + //- Return const-access to phase2 viscosityModel + const viscosityModel& nuModel2() const + { + return nuModel2_(); + } + + //- Return const-access to phase3 viscosityModel + const viscosityModel& nuModel3() const + { + return nuModel3_(); + } + //- Return the dynamic laminar viscosity tmp mu() const; diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.C b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.C index 0e9e8ae349..f7cc2eae21 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.C +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.C @@ -42,11 +42,10 @@ namespace phaseChangeTwoPhaseMixtures Foam::phaseChangeTwoPhaseMixtures::Kunz::Kunz ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name + const surfaceScalarField& phi ) : - phaseChangeTwoPhaseMixture(typeName, U, phi, alpha1Name), + phaseChangeTwoPhaseMixture(typeName, U, phi), UInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("UInf")), tInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("tInf")), diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.H b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.H index 39ccad5382..f0290efc95 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.H +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Kunz/Kunz.H @@ -91,8 +91,7 @@ public: Kunz ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name = "alpha1" + const surfaceScalarField& phi ); diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.C b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.C index 87c261da9b..72fdb7245e 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.C +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.C @@ -42,11 +42,10 @@ namespace phaseChangeTwoPhaseMixtures Foam::phaseChangeTwoPhaseMixtures::Merkle::Merkle ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name + const surfaceScalarField& phi ) : - phaseChangeTwoPhaseMixture(typeName, U, phi, alpha1Name), + phaseChangeTwoPhaseMixture(typeName, U, phi), UInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("UInf")), tInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("tInf")), diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.H b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.H index 7dd8e841c8..e675c83df7 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.H +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/Merkle/Merkle.H @@ -85,8 +85,7 @@ public: Merkle ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name = "alpha1" + const surfaceScalarField& phi ); diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.C b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.C index 36cb56a0c2..f157fa75e0 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.C +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.C @@ -49,11 +49,10 @@ namespace phaseChangeTwoPhaseMixtures Foam::phaseChangeTwoPhaseMixtures::SchnerrSauer::SchnerrSauer ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name + const surfaceScalarField& phi ) : - phaseChangeTwoPhaseMixture(typeName, U, phi, alpha1Name), + phaseChangeTwoPhaseMixture(typeName, U, phi), n_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("n")), dNuc_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("dNuc")), diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.H b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.H index beef7fc7fc..ce096105d9 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.H +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/SchnerrSauer/SchnerrSauer.H @@ -98,8 +98,7 @@ public: SchnerrSauer ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name = "alpha1" + const surfaceScalarField& phi ); diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/newPhaseChangeTwoPhaseMixture.C b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/newPhaseChangeTwoPhaseMixture.C index 08728c8f92..0a86459705 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/newPhaseChangeTwoPhaseMixture.C +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/newPhaseChangeTwoPhaseMixture.C @@ -32,8 +32,7 @@ Foam::autoPtr Foam::phaseChangeTwoPhaseMixture::New ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name + const surfaceScalarField& phi ) { IOdictionary transportPropertiesDict @@ -73,7 +72,7 @@ Foam::phaseChangeTwoPhaseMixture::New << exit(FatalError); } - return autoPtr(cstrIter()(U, phi, alpha1Name)); + return autoPtr(cstrIter()(U, phi)); } diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.C b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.C index c08eba9390..d25fbdfec9 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.C +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.C @@ -39,11 +39,10 @@ Foam::phaseChangeTwoPhaseMixture::phaseChangeTwoPhaseMixture ( const word& type, const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name + const surfaceScalarField& phi ) : - incompressibleTwoPhaseMixture(U, phi, alpha1Name), + incompressibleTwoPhaseMixture(U, phi), phaseChangeTwoPhaseMixtureCoeffs_(subDict(type + "Coeffs")), pSat_(lookup("pSat")) {} diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.H b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.H index e05476390b..227768ac8d 100644 --- a/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.H +++ b/applications/solvers/multiphase/interPhaseChangeFoam/phaseChangeTwoPhaseMixtures/phaseChangeTwoPhaseMixture/phaseChangeTwoPhaseMixture.H @@ -91,10 +91,9 @@ public: components, ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name + const surfaceScalarField& phi ), - (U, phi, alpha1Name) + (U, phi) ); @@ -104,8 +103,7 @@ public: static autoPtr New ( const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name = "alpha1" + const surfaceScalarField& phi ); @@ -116,8 +114,7 @@ public: ( const word& type, const volVectorField& U, - const surfaceScalarField& phi, - const word& alpha1Name = "alpha1" + const surfaceScalarField& phi ); diff --git a/applications/solvers/multiphase/twoLiquidMixingFoam/alphaEqn.H b/applications/solvers/multiphase/twoLiquidMixingFoam/alphaEqn.H index c68a0e56c5..adca48e965 100644 --- a/applications/solvers/multiphase/twoLiquidMixingFoam/alphaEqn.H +++ b/applications/solvers/multiphase/twoLiquidMixingFoam/alphaEqn.H @@ -1,5 +1,5 @@ { - word alphaScheme("div(phi,alpha1)"); + word alphaScheme("div(phi,alpha)"); surfaceScalarField phiAlpha ( diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/Allwclean b/applications/solvers/multiphase/twoPhaseEulerFoam/Allwclean index cc138bc068..8af1402435 100755 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/Allwclean +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/Allwclean @@ -2,9 +2,9 @@ cd ${0%/*} || exit 1 # run from this directory set -x -wclean libso phaseModel +wclean libso twoPhaseSystem wclean libso interfacialModels -wclean libso kineticTheoryModels +wclean libso phaseIncompressibleTurbulenceModels wclean # ----------------------------------------------------------------- end-of-file diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/Allwmake b/applications/solvers/multiphase/twoPhaseEulerFoam/Allwmake index 29294d166a..6ba04af789 100755 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/Allwmake +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/Allwmake @@ -2,9 +2,10 @@ cd ${0%/*} || exit 1 # run from this directory set -x -wmake libso phaseModel +wmakeLnInclude interfacialModels +wmake libso twoPhaseSystem wmake libso interfacialModels -wmake libso kineticTheoryModels +wmake libso phaseIncompressibleTurbulenceModels wmake # ----------------------------------------------------------------- end-of-file diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/CourantNo.H b/applications/solvers/multiphase/twoPhaseEulerFoam/CourantNo.H similarity index 95% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/CourantNo.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/CourantNo.H index 4bfc58978e..b09f5e7ac2 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/CourantNo.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/CourantNo.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/EEqns.H b/applications/solvers/multiphase/twoPhaseEulerFoam/EEqns.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/EEqns.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/EEqns.H diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options b/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options index f4a6229714..e178081548 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/Make/options @@ -1,16 +1,23 @@ EXE_INC = \ + -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/transportModels/incompressible/lnInclude \ - -IturbulenceModel \ - -IkineticTheoryModels/lnInclude \ + -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \ + -I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \ + -I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude \ + -IphaseIncompressibleTurbulenceModels/lnInclude \ -IinterfacialModels/lnInclude \ - -IphaseModel/lnInclude \ + -ItwoPhaseSystem/lnInclude \ -Iaveraging EXE_LIBS = \ - -lEulerianInterfacialModels \ - -lfiniteVolume \ - -lmeshTools \ + -lfluidThermophysicalModels \ + -lspecie \ + -lturbulenceModels \ + -lincompressibleTurbulenceModels \ + -lphaseIncompressibleTurbulenceModels \ -lincompressibleTransportModels \ - -lphaseModel \ - -lkineticTheoryModel + -lcompressibleTwoPhaseSystem \ + -lcompressibleEulerianInterfacialModels \ + -lfiniteVolume \ + -lmeshTools diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/UEqns.H b/applications/solvers/multiphase/twoPhaseEulerFoam/UEqns.H index 6fae832a21..dea48be335 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/UEqns.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/UEqns.H @@ -1,99 +1,61 @@ +mrfZones.correctBoundaryVelocity(U1); +mrfZones.correctBoundaryVelocity(U2); +mrfZones.correctBoundaryVelocity(U); + fvVectorMatrix U1Eqn(U1, U1.dimensions()*dimVol/dimTime); fvVectorMatrix U2Eqn(U2, U2.dimensions()*dimVol/dimTime); +volScalarField dragCoeff(fluid.dragCoeff()); + { + volVectorField liftForce(fluid.liftForce(U)); + { - volTensorField gradU1T(T(fvc::grad(U1))); - - if (kineticTheory.on()) - { - kineticTheory.solve(gradU1T); - nuEff1 = kineticTheory.mu1()/rho1; - } - else // If not using kinetic theory is using Ct model - { - nuEff1 = sqr(Ct)*nut2 + nu1; - } - - volTensorField Rc1 - ( - "Rc1", - (((2.0/3.0)*I)*nuEff1)*tr(gradU1T) - nuEff1*gradU1T - ); - - if (kineticTheory.on()) - { - Rc1 -= ((kineticTheory.lambda()/rho1)*tr(gradU1T))*tensor(I); - } - - surfaceScalarField phiR1 - ( - -fvc::interpolate(nuEff1)*mesh.magSf()*fvc::snGrad(alpha1) - /fvc::interpolate(alpha1 + scalar(0.001)) - ); - U1Eqn = ( - (scalar(1) + Cvm*rho2*alpha2/rho1)* + fvm::ddt(alpha1, U1) + + fvm::div(alphaPhi1, U1) + + // Compressibity correction + - fvm::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), U1) + + + fluid.Cvm()*rho2*alpha1*alpha2/rho1* ( fvm::ddt(U1) - + fvm::div(phi1, U1, "div(phi1,U1)") + + fvm::div(phi1, U1) - fvm::Sp(fvc::div(phi1), U1) ) - - fvm::laplacian(nuEff1, U1) - + fvc::div(Rc1) - - + fvm::div(phiR1, U1, "div(phi1,U1)") - - fvm::Sp(fvc::div(phiR1), U1) - + (fvc::grad(alpha1)/(fvc::average(alpha1) + scalar(0.001)) & Rc1) + + turbulence1->divDevReff(U1) == - // g // Buoyancy term transfered to p-equation - - fvm::Sp(alpha2/rho1*K, U1) - //+ alpha2/rho1*K*U2 // Explicit drag transfered to p-equation - - alpha2/rho1*(liftCoeff - Cvm*rho2*DDtU2) + - fvm::Sp(dragCoeff/rho1, U1) + - alpha1*alpha2/rho1*(liftForce - fluid.Cvm()*rho2*DDtU2) ); - mrfZones.addCoriolis(scalar(1) + Cvm*rho2*alpha2/rho1, U1Eqn); + mrfZones.addCoriolis(alpha1*(1 + fluid.Cvm()*rho2*alpha2/rho1), U1Eqn); U1Eqn.relax(); } { - volTensorField gradU2T(T(fvc::grad(U2))); - volTensorField Rc2 - ( - "Rc2", - (((2.0/3.0)*I)*nuEff2)*tr(gradU2T) - nuEff2*gradU2T - ); - - surfaceScalarField phiR2 - ( - -fvc::interpolate(nuEff2)*mesh.magSf()*fvc::snGrad(alpha2) - /fvc::interpolate(alpha2 + scalar(0.001)) - ); - U2Eqn = ( - (scalar(1) + Cvm*rho2*alpha1/rho2)* + fvm::ddt(alpha2, U2) + + fvm::div(alphaPhi2, U2) + + // Compressibity correction + - fvm::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), U2) + + + fluid.Cvm()*rho2*alpha1*alpha2/rho2* ( fvm::ddt(U2) - + fvm::div(phi2, U2, "div(phi2,U2)") + + fvm::div(phi2, U2) - fvm::Sp(fvc::div(phi2), U2) ) - - - fvm::laplacian(nuEff2, U2) - + fvc::div(Rc2) - - + fvm::div(phiR2, U2, "div(phi2,U2)") - - fvm::Sp(fvc::div(phiR2), U2) - - + (fvc::grad(alpha2)/(fvc::average(alpha2) + scalar(0.001)) & Rc2) + + turbulence2->divDevReff(U2) == - // g // Buoyancy term transfered to p-equation - - fvm::Sp(alpha1/rho2*K, U2) - //+ alpha1/rho2*K*U1 // Explicit drag transfered to p-equation - + alpha1/rho2*(liftCoeff + Cvm*rho2*DDtU1) + - fvm::Sp(dragCoeff/rho2, U2) + + alpha1*alpha2/rho2*(liftForce + fluid.Cvm()*rho2*DDtU1) ); - mrfZones.addCoriolis(scalar(1) + Cvm*rho2*alpha1/rho2, U2Eqn); + mrfZones.addCoriolis(alpha2*(1 + fluid.Cvm()*rho2*alpha1/rho2), U2Eqn); U2Eqn.relax(); } } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/alphaEqn.H b/applications/solvers/multiphase/twoPhaseEulerFoam/alphaEqn.H index ae21059446..8ce175b85c 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/alphaEqn.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/alphaEqn.H @@ -1,20 +1,75 @@ { - word alphaScheme("div(phi,alpha1)"); - word alpharScheme("div(phir,alpha1)"); + word alphaScheme("div(phi," + alpha1.name() + ')'); + word alpharScheme("div(phir," + alpha1.name() + ')'); surfaceScalarField phic("phic", phi); surfaceScalarField phir("phir", phi1 - phi2); - if (g0.value() > 0.0) + surfaceScalarField alpha1f(fvc::interpolate(max(alpha1, scalar(0)))); + + tmp pPrimeByA; + + if (implicitPhasePressure) { - surfaceScalarField alpha1f(fvc::interpolate(alpha1)); - surfaceScalarField phipp(ppMagf*fvc::snGrad(alpha1)*mesh.magSf()); - phir += phipp; - phic += alpha1f*phipp; + pPrimeByA = + fvc::interpolate((1.0/rho1)*rAU1*turbulence1().pPrime()) + + fvc::interpolate((1.0/rho2)*rAU2*turbulence2().pPrime()); + + surfaceScalarField phiP + ( + pPrimeByA()*fvc::snGrad(alpha1, "bounded")*mesh.magSf() + ); + + phic += alpha1f*phiP; + phir += phiP; } for (int acorr=0; acorr 0.0 && alpha1[celli] > 0.0) + { + Sp[celli] -= dgdt[celli]*alpha1[celli]; + Su[celli] += dgdt[celli]*alpha1[celli]; + } + else if (dgdt[celli] < 0.0 && alpha1[celli] < 1.0) + { + Sp[celli] += dgdt[celli]*(1.0 - alpha1[celli]); + } + } + + dimensionedScalar totalDeltaT = runTime.deltaT(); + if (nAlphaSubCycles > 1) + { + alphaPhi1 = dimensionedScalar("0", alphaPhi1.dimensions(), 0); + } + for ( subCycle alphaSubCycle(alpha1, nAlphaSubCycles); @@ -31,47 +86,56 @@ ) + fvc::flux ( - -fvc::flux(-phir, alpha2, alpharScheme), + -fvc::flux(-phir, scalar(1) - alpha1, alpharScheme), alpha1, alpharScheme ) ); + // Ensure that the flux at inflow BCs is preserved + alphaPhic1.boundaryField() = min + ( + phi1.boundaryField()*alpha1.boundaryField(), + alphaPhic1.boundaryField() + ); + MULES::explicitSolve ( + geometricOneField(), alpha1, phi, alphaPhic1, - (g0.value() > 0 ? alphaMax : 1), + Sp, + Su, + 1, 0 ); + + if (nAlphaSubCycles > 1) + { + alphaPhi1 += (runTime.deltaT()/totalDeltaT)*alphaPhic1; + } + else + { + alphaPhi1 = alphaPhic1; + } } - if (g0.value() > 0) + if (implicitPhasePressure) { - surfaceScalarField alpha1f(fvc::interpolate(alpha1)); - - ppMagf = - rAU1f/(alpha1f + scalar(0.0001)) - *(g0/rho1)*min(exp(preAlphaExp*(alpha1f - alphaMax)), expMax); - fvScalarMatrix alpha1Eqn ( fvm::ddt(alpha1) - fvc::ddt(alpha1) - - fvm::laplacian - ( - alpha1f*ppMagf, - alpha1, - "laplacian(alpha1PpMag,alpha1)" - ) + - fvm::laplacian(alpha1f*pPrimeByA, alpha1, "bounded") ); alpha1Eqn.relax(); alpha1Eqn.solve(); - #include "packingLimiter.H" + alphaPhi1 += alpha1Eqn.flux(); } + alphaPhi2 = phi - alphaPhi1; alpha2 = scalar(1) - alpha1; Info<< "Dispersed phase volume fraction = " @@ -82,4 +146,4 @@ } } -rho = alpha1*rho1 + alpha2*rho2; +rho = fluid.rho(); diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H b/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H index 314d9b55ea..f279445cf6 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/createFields.H @@ -1,82 +1,46 @@ - Info<< "Reading transportProperties\n" << endl; + Info<< "Creating twoPhaseSystem\n" << endl; - IOdictionary transportProperties + twoPhaseSystem fluid(mesh); + + phaseModel& phase1 = fluid.phase1(); + phaseModel& phase2 = fluid.phase2(); + + volScalarField& alpha1 = phase1; + volScalarField& alpha2 = phase2; + + volVectorField& U1 = phase1.U(); + surfaceScalarField& phi1 = phase1.phi(); + surfaceScalarField alphaPhi1 ( - IOobject - ( - "transportProperties", - runTime.constant(), - mesh, - IOobject::MUST_READ, - IOobject::NO_WRITE - ) + IOobject::groupName("alphaPhi", phase1.name()), + fvc::interpolate(alpha1)*phi1 ); - autoPtr phase1 = phaseModel::New + volVectorField& U2 = phase2.U(); + surfaceScalarField& phi2 = phase2.phi(); + surfaceScalarField alphaPhi2 ( - mesh, - transportProperties, - "1" + IOobject::groupName("alphaPhi", phase2.name()), + fvc::interpolate(alpha2)*phi2 ); - autoPtr phase2 = phaseModel::New + dimensionedScalar pMin ( - mesh, - transportProperties, - "2" + "pMin", + dimPressure, + fluid.lookup("pMin") ); - volVectorField& U1 = phase1->U(); - surfaceScalarField& phi1 = phase1->phi(); - const dimensionedScalar& rho1 = phase1->rho(); - const dimensionedScalar& nu1 = phase1->nu(); + rhoThermo& thermo1 = phase1.thermo(); + rhoThermo& thermo2 = phase2.thermo(); - volVectorField& U2 = phase2->U(); - surfaceScalarField& phi2 = phase2->phi(); - const dimensionedScalar& rho2 = phase2->rho(); - const dimensionedScalar& nu2 = phase2->nu(); + volScalarField& p = thermo1.p(); - Info<< "Reading field alpha1\n" << endl; - volScalarField alpha1 - ( - IOobject - ( - "alpha1", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); + volScalarField& rho1 = thermo1.rho(); + const volScalarField& psi1 = thermo1.psi(); - volScalarField alpha2 - ( - IOobject - ( - "alpha2", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::NO_WRITE - ), - scalar(1) - alpha1 - //,alpha1.boundaryField().types() - ); - - Info<< "Reading field p\n" << endl; - volScalarField p - ( - IOobject - ( - "p", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ); + volScalarField& rho2 = thermo2.rho(); + const volScalarField& psi2 = thermo2.psi(); volVectorField U ( @@ -88,28 +52,7 @@ IOobject::NO_READ, IOobject::AUTO_WRITE ), - alpha1*U1 + alpha2*U2 - ); - - dimensionedScalar Cvm - ( - "Cvm", - dimless, - transportProperties.lookup("Cvm") - ); - - dimensionedScalar Cl - ( - "Cl", - dimless, - transportProperties.lookup("Cl") - ); - - dimensionedScalar Ct - ( - "Ct", - dimless, - transportProperties.lookup("Ct") + fluid.U() ); surfaceScalarField phi @@ -122,7 +65,7 @@ IOobject::NO_READ, IOobject::AUTO_WRITE ), - fvc::interpolate(alpha1)*phi1 + fvc::interpolate(alpha2)*phi2 + fluid.phi() ); volScalarField rho @@ -131,13 +74,13 @@ ( "rho", runTime.timeName(), - mesh + mesh, + IOobject::NO_READ, + IOobject::AUTO_WRITE ), - alpha1*rho1 + alpha2*rho2 + fluid.rho() ); - #include "createRASTurbulence.H" - Info<< "Calculating field DDtU1 and DDtU2\n" << endl; volVectorField DDtU1 @@ -158,75 +101,11 @@ Info<< "Calculating field g.h\n" << endl; volScalarField gh("gh", g & mesh.C()); - IOdictionary interfacialProperties + volScalarField rAU1 ( IOobject ( - "interfacialProperties", - runTime.constant(), - mesh, - IOobject::MUST_READ, - IOobject::NO_WRITE - ) - ); - - autoPtr drag1 = dragModel::New - ( - interfacialProperties, - alpha1, - phase1, - phase2 - ); - - autoPtr drag2 = dragModel::New - ( - interfacialProperties, - alpha2, - phase2, - phase1 - ); - - word dragPhase("blended"); - if (interfacialProperties.found("dragPhase")) - { - dragPhase = word(interfacialProperties.lookup("dragPhase")); - - bool validDrag = - dragPhase == "1" || dragPhase == "2" || dragPhase == "blended"; - - if (!validDrag) - { - FatalErrorIn(args.executable()) - << "invalid dragPhase " << dragPhase - << exit(FatalError); - } - } - - dimensionedScalar residualSlip - ( - dimensionedScalar::lookupOrDefault - ( - "residualSlip", - interfacialProperties, - 0, - dimVelocity - ) - ); - - Info << "dragPhase is " << dragPhase << endl; - kineticTheoryModel kineticTheory - ( - phase1, - U2, - alpha1, - drag1 - ); - - surfaceScalarField rAU1f - ( - IOobject - ( - "rAU1f", + IOobject::groupName("rAU", phase1.name()), runTime.timeName(), mesh, IOobject::NO_READ, @@ -236,21 +115,71 @@ dimensionedScalar("zero", dimensionSet(0, 0, 1, 0, 0), 0.0) ); - surfaceScalarField ppMagf + volScalarField rAU2 ( IOobject ( - "ppMagf", + IOobject::groupName("rAU", phase2.name()), runTime.timeName(), mesh, IOobject::NO_READ, IOobject::NO_WRITE ), mesh, - dimensionedScalar("zero", dimensionSet(0, 2, -1, 0, 0), 0.0) + dimensionedScalar("zero", dimensionSet(0, 0, 1, 0, 0), 0.0) ); - label pRefCell = 0; scalar pRefValue = 0.0; setRefCell(p, mesh.solutionDict().subDict("PIMPLE"), pRefCell, pRefValue); + + + volScalarField dgdt + ( + pos(alpha2)*fvc::div(phi)/max(alpha2, scalar(0.0001)) + ); + + + Info<< "Creating field dpdt\n" << endl; + volScalarField dpdt + ( + IOobject + ( + "dpdt", + runTime.timeName(), + mesh + ), + mesh, + dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) + ); + + + Info<< "Creating field kinetic energy K\n" << endl; + volScalarField K1(IOobject::groupName("K", phase1.name()), 0.5*magSqr(U1)); + volScalarField K2(IOobject::groupName("K", phase2.name()), 0.5*magSqr(U2)); + + autoPtr > + turbulence1 + ( + PhaseIncompressibleTurbulenceModel::New + ( + alpha1, + U1, + alphaPhi1, + phi1, + phase1 + ) + ); + + autoPtr > + turbulence2 + ( + PhaseIncompressibleTurbulenceModel::New + ( + alpha2, + U2, + alphaPhi2, + phi2, + phase2 + ) + ); diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/createRASTurbulence.H b/applications/solvers/multiphase/twoPhaseEulerFoam/createRASTurbulence.H deleted file mode 100644 index bacd835655..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/createRASTurbulence.H +++ /dev/null @@ -1,178 +0,0 @@ - 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 alpha1k - ( - dimensionedScalar::lookupOrAddToDict - ( - "alpha1k", - kEpsilonDict, - 1.0 - ) - ); - - dimensionedScalar alpha1Eps - ( - dimensionedScalar::lookupOrAddToDict - ( - "alpha1Eps", - kEpsilonDict, - 0.76923 - ) - ); - - 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 nut2\n" << endl; - volScalarField nut2 - ( - IOobject - ( - "nut2", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - Cmu*sqr(k)/epsilon - ); - - Info<< "Calculating field nuEff1\n" << endl; - volScalarField nuEff1 - ( - IOobject - ( - "nuEff1", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::NO_WRITE - ), - sqr(Ct)*nut2 + nu1 - ); - - Info<< "Calculating field nuEff2\n" << endl; - volScalarField nuEff2 - ( - IOobject - ( - "nuEff2", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::NO_WRITE - ), - nut2 + nu2 - ); diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/files b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/files index 8d23cb9550..43c0f9b2a9 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/files +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/files @@ -8,4 +8,8 @@ dragModels/Gibilaro/Gibilaro.C dragModels/WenYu/WenYu.C dragModels/SyamlalOBrien/SyamlalOBrien.C -LIB = $(FOAM_LIBBIN)/libEulerianInterfacialModels +heatTransferModels/heatTransferModel/heatTransferModel.C +heatTransferModels/heatTransferModel/newHeatTransferModel.C +heatTransferModels/RanzMarshall/RanzMarshall.C + +LIB = $(FOAM_LIBBIN)/libcompressibleEulerianInterfacialModels diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/options b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/options index 42c2cb54c9..e7e60696ec 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/options +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/Make/options @@ -1,6 +1,10 @@ EXE_INC = \ + -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ + -I$(LIB_SRC)/transportModels/incompressible/transportModel \ -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I../phaseModel/lnInclude + -I../twoPhaseSystem/lnInclude LIB_LIBS = \ - -lphaseModel + -lcompressibleTwoPhaseSystem \ + -lfluidThermophysicalModels \ + -lspecie diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.C index e3a7ffd097..ced13ced8f 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,6 +29,8 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // namespace Foam +{ +namespace dragModels { defineTypeNameAndDebug(Ergun, 0); @@ -39,11 +41,12 @@ namespace Foam dictionary ); } +} // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // -Foam::Ergun::Ergun +Foam::dragModels::Ergun::Ergun ( const dictionary& interfaceDict, const volScalarField& alpha1, @@ -57,13 +60,13 @@ Foam::Ergun::Ergun // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // -Foam::Ergun::~Ergun() +Foam::dragModels::Ergun::~Ergun() {} // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -Foam::tmp Foam::Ergun::K +Foam::tmp Foam::dragModels::Ergun::K ( const volScalarField& Ur ) const diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.H index 2a3de8192c..75d5de107a 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Ergun/Ergun.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Class - Foam::Ergun + Foam::dragModels::Ergun Description H, Enwald, E. Peirano, A-E Almstedt @@ -44,6 +44,8 @@ SourceFiles namespace Foam { +namespace dragModels +{ /*---------------------------------------------------------------------------*\ Class Ergun Declaration @@ -84,6 +86,7 @@ public: // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +} // End namespace dragModels } // End namespace Foam // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.C index cbb9fb9ade..093b86d70a 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,6 +29,8 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // namespace Foam +{ +namespace dragModels { defineTypeNameAndDebug(Gibilaro, 0); @@ -39,11 +41,12 @@ namespace Foam dictionary ); } +} // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // -Foam::Gibilaro::Gibilaro +Foam::dragModels::Gibilaro::Gibilaro ( const dictionary& interfaceDict, const volScalarField& alpha1, @@ -57,13 +60,13 @@ Foam::Gibilaro::Gibilaro // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // -Foam::Gibilaro::~Gibilaro() +Foam::dragModels::Gibilaro::~Gibilaro() {} // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -Foam::tmp Foam::Gibilaro::K +Foam::tmp Foam::dragModels::Gibilaro::K ( const volScalarField& Ur ) const diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.H index 9be5dd8cf3..2a922c86d9 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Gibilaro/Gibilaro.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Class - Foam::Gibilaro + Foam::dragModels::Gibilaro Description H, Enwald, E. Peirano, A-E Almstedt @@ -44,6 +44,8 @@ SourceFiles namespace Foam { +namespace dragModels +{ /*---------------------------------------------------------------------------*\ Class Gibilaro Declaration @@ -84,6 +86,7 @@ public: // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +} // End namespace dragModels } // End namespace Foam // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C index 5cf712a251..deb949de21 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,6 +29,8 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // namespace Foam +{ +namespace dragModels { defineTypeNameAndDebug(GidaspowErgunWenYu, 0); @@ -39,11 +41,12 @@ namespace Foam dictionary ); } +} // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // -Foam::GidaspowErgunWenYu::GidaspowErgunWenYu +Foam::dragModels::GidaspowErgunWenYu::GidaspowErgunWenYu ( const dictionary& interfaceDict, const volScalarField& alpha1, @@ -57,21 +60,21 @@ Foam::GidaspowErgunWenYu::GidaspowErgunWenYu // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // -Foam::GidaspowErgunWenYu::~GidaspowErgunWenYu() +Foam::dragModels::GidaspowErgunWenYu::~GidaspowErgunWenYu() {} // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -Foam::tmp Foam::GidaspowErgunWenYu::K +Foam::tmp Foam::dragModels::GidaspowErgunWenYu::K ( const volScalarField& Ur ) const { volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1.0e-6))); - + volScalarField d(phase1_.d()); volScalarField bp(pow(alpha2, -2.65)); - volScalarField Re(max(Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); + volScalarField Re(max(Ur*d/phase2_.nu(), scalar(1.0e-3))); volScalarField Cds ( @@ -83,11 +86,11 @@ Foam::tmp Foam::GidaspowErgunWenYu::K return ( pos(alpha2 - 0.8) - *(0.75*Cds*phase2_.rho()*Ur*bp/phase1_.d()) + *(0.75*Cds*phase2_.rho()*Ur*bp/d) + neg(alpha2 - 0.8) *( - 150.0*alpha1_*phase2_.nu()*phase2_.rho()/(sqr(alpha2*phase1_.d())) - + 1.75*phase2_.rho()*Ur/(alpha2*phase1_.d()) + 150.0*alpha1_*phase2_.nu()*phase2_.rho()/(sqr(alpha2*d)) + + 1.75*phase2_.rho()*Ur/(alpha2*d) ) ); } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.H index 64dfdc08cc..9c2a25ac0a 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowErgunWenYu/GidaspowErgunWenYu.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Class - Foam::GidaspowErgunWenYu + Foam::dragModels::GidaspowErgunWenYu Description D. Gidaspow, Multiphase flow and fluidization, @@ -42,6 +42,8 @@ SourceFiles namespace Foam { +namespace dragModels +{ /*---------------------------------------------------------------------------*\ Class GidaspowErgunWenYu Declaration @@ -82,6 +84,7 @@ public: // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +} // End namespace dragModels } // End namespace Foam // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C index f6438794f7..c6ebe66092 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,6 +29,8 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // namespace Foam +{ +namespace dragModels { defineTypeNameAndDebug(GidaspowSchillerNaumann, 0); @@ -39,11 +41,12 @@ namespace Foam dictionary ); } +} // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // -Foam::GidaspowSchillerNaumann::GidaspowSchillerNaumann +Foam::dragModels::GidaspowSchillerNaumann::GidaspowSchillerNaumann ( const dictionary& interfaceDict, const volScalarField& alpha1, @@ -57,13 +60,13 @@ Foam::GidaspowSchillerNaumann::GidaspowSchillerNaumann // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // -Foam::GidaspowSchillerNaumann::~GidaspowSchillerNaumann() +Foam::dragModels::GidaspowSchillerNaumann::~GidaspowSchillerNaumann() {} // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -Foam::tmp Foam::GidaspowSchillerNaumann::K +Foam::tmp Foam::dragModels::GidaspowSchillerNaumann::K ( const volScalarField& Ur ) const @@ -72,7 +75,6 @@ Foam::tmp Foam::GidaspowSchillerNaumann::K volScalarField bp(pow(alpha2, -2.65)); volScalarField Re(max(alpha2*Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); - volScalarField Cds ( neg(Re - 1000)*(24.0*(1.0 + 0.15*pow(Re, 0.687))/Re) diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.H index 3199c2eb54..dcc07aec6c 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/GidaspowSchillerNaumann/GidaspowSchillerNaumann.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Class - Foam::GidaspowSchillerNaumann + Foam::dragModels::GidaspowSchillerNaumann Description H, Enwald, E. Peirano, A-E Almstedt @@ -51,6 +51,8 @@ SourceFiles namespace Foam { +namespace dragModels +{ /*---------------------------------------------------------------------------*\ Class GidaspowSchillerNaumann Declaration @@ -91,6 +93,7 @@ public: // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +} // End namespace dragModels } // End namespace Foam // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.C index 184f644466..4ab62e14a7 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,6 +29,8 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // namespace Foam +{ +namespace dragModels { defineTypeNameAndDebug(SchillerNaumann, 0); @@ -39,11 +41,12 @@ namespace Foam dictionary ); } +} // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // -Foam::SchillerNaumann::SchillerNaumann +Foam::dragModels::SchillerNaumann::SchillerNaumann ( const dictionary& interfaceDict, const volScalarField& alpha1, @@ -57,19 +60,18 @@ Foam::SchillerNaumann::SchillerNaumann // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // -Foam::SchillerNaumann::~SchillerNaumann() +Foam::dragModels::SchillerNaumann::~SchillerNaumann() {} // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -Foam::tmp Foam::SchillerNaumann::K +Foam::tmp Foam::dragModels::SchillerNaumann::K ( const volScalarField& Ur ) const { volScalarField Re(max(Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); - volScalarField Cds ( neg(Re - 1000)*(24.0*(1.0 + 0.15*pow(Re, 0.687))/Re) diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.H index c2962f3b42..00aacd4469 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SchillerNaumann/SchillerNaumann.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Class - Foam::SchillerNaumann + Foam::dragModels::SchillerNaumann Description @@ -40,6 +40,8 @@ SourceFiles namespace Foam { +namespace dragModels +{ /*---------------------------------------------------------------------------*\ Class SchillerNaumann Declaration @@ -80,6 +82,7 @@ public: // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +} // End namespace dragModels } // End namespace Foam // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.C index 9cb0ce7854..ff6abc1857 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,6 +29,8 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // namespace Foam +{ +namespace dragModels { defineTypeNameAndDebug(SyamlalOBrien, 0); @@ -39,11 +41,12 @@ namespace Foam dictionary ); } +} // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // -Foam::SyamlalOBrien::SyamlalOBrien +Foam::dragModels::SyamlalOBrien::SyamlalOBrien ( const dictionary& interfaceDict, const volScalarField& alpha1, @@ -57,13 +60,13 @@ Foam::SyamlalOBrien::SyamlalOBrien // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // -Foam::SyamlalOBrien::~SyamlalOBrien() +Foam::dragModels::SyamlalOBrien::~SyamlalOBrien() {} // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -Foam::tmp Foam::SyamlalOBrien::K +Foam::tmp Foam::dragModels::SyamlalOBrien::K ( const volScalarField& Ur ) const diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.H index adc4b439a8..210b49d200 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/SyamlalOBrien/SyamlalOBrien.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Class - Foam::SyamlalOBrien + Foam::dragModels::SyamlalOBrien Description Syamlal, M., Rogers, W. and O'Brien, T. J. (1993) MFIX documentation, @@ -43,6 +43,8 @@ SourceFiles namespace Foam { +namespace dragModels +{ /*---------------------------------------------------------------------------*\ Class SyamlalOBrien Declaration @@ -83,6 +85,7 @@ public: // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +} // End namespace dragModels } // End namespace Foam // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.C index 5de283e7da..b31aa21fb6 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,6 +29,8 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // namespace Foam +{ +namespace dragModels { defineTypeNameAndDebug(WenYu, 0); @@ -39,11 +41,12 @@ namespace Foam dictionary ); } +} // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // -Foam::WenYu::WenYu +Foam::dragModels::WenYu::WenYu ( const dictionary& interfaceDict, const volScalarField& alpha1, @@ -57,18 +60,19 @@ Foam::WenYu::WenYu // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // -Foam::WenYu::~WenYu() +Foam::dragModels::WenYu::~WenYu() {} // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -Foam::tmp Foam::WenYu::K +Foam::tmp Foam::dragModels::WenYu::K ( const volScalarField& Ur ) const { volScalarField alpha2(max(scalar(1) - alpha1_, scalar(1.0e-6))); + volScalarField bp(pow(alpha2, -2.65)); volScalarField Re(max(Ur*phase1_.d()/phase2_.nu(), scalar(1.0e-3))); volScalarField Cds @@ -77,7 +81,7 @@ Foam::tmp Foam::WenYu::K + pos(Re - 1000)*0.44 ); - return 0.75*Cds*phase2_.rho()*Ur*pow(alpha2, -2.65)/phase1_.d(); + return 0.75*Cds*phase2_.rho()*Ur*bp/phase1_.d(); } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.H index 16a1978f4f..6d9affca9f 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/WenYu/WenYu.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Class - Foam::WenYu + Foam::dragModels::WenYu Description H, Enwald, E. Peirano, A-E Almstedt @@ -54,6 +54,8 @@ SourceFiles namespace Foam { +namespace dragModels +{ /*---------------------------------------------------------------------------*\ Class WenYu Declaration @@ -94,6 +96,7 @@ public: // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // +} // End namespace dragModels } // End namespace Foam // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.H index 5a29f36354..6e47aedb4d 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/dragModel.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -114,12 +114,12 @@ public: //- the dragfunction K used in the momentum eq. // ddt(alpha1*rho1*U1) + ... = ... alpha1*alpha2*K*(U1-U2) // ddt(alpha2*rho2*U2) + ... = ... alpha1*alpha2*K*(U2-U1) - // ********************************** NB ! ***************************** + // ********************************** NB! ***************************** // for numerical reasons alpha1 and alpha2 has been // extracted from the dragFunction K, // so you MUST divide K by alpha1*alpha2 when implemnting the drag // function - // ********************************** NB ! ***************************** + // ********************************** NB! ***************************** virtual tmp K(const volScalarField& Ur) const = 0; }; diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/newDragModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/newDragModel.C index b71a9a692e..9f20a3c22d 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/newDragModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/dragModel/newDragModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -37,7 +37,7 @@ Foam::autoPtr Foam::dragModel::New { word dragModelType ( - interfaceDict.lookup("dragModel" + phase1.name()) + interfaceDict.lookup(phase1.name()) ); Info << "Selecting dragModel for phase " @@ -50,14 +50,12 @@ Foam::autoPtr Foam::dragModel::New if (cstrIter == dictionaryConstructorTablePtr_->end()) { - FatalError - << "dragModel::New : " << endl - << " unknown dragModelType type " - << dragModelType - << ", constructor not in hash table" << endl << endl - << " Valid dragModel types are : " << endl; - Info << dictionaryConstructorTablePtr_->sortedToc() - << abort(FatalError); + FatalErrorIn("dragModel::New") + << "Unknown dragModelType type " + << dragModelType << endl << endl + << "Valid dragModel types are : " << endl + << dictionaryConstructorTablePtr_->sortedToc() + << exit(FatalError); } return cstrIter()(interfaceDict, alpha1, phase1, phase2); diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.H similarity index 97% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.H index 6f3d3f9845..8bcad969a8 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/RanzMarshall/RanzMarshall.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.C index b6a85e7cd6..40facd1fe6 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H similarity index 98% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H index 47e14fc8c7..f869f8c0e9 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/newHeatTransferModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/newHeatTransferModel.C similarity index 97% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/newHeatTransferModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/newHeatTransferModel.C index cf3ae97412..757fb94351 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/newHeatTransferModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/heatTransferModels/heatTransferModel/newHeatTransferModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kEpsilon.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kEpsilon.H deleted file mode 100644 index 1340587ea3..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kEpsilon.H +++ /dev/null @@ -1,64 +0,0 @@ -if (turbulence) -{ - if (mesh.changing()) - { - y.correct(); - } - - tmp tgradU2 = fvc::grad(U2); - volScalarField G(2*nut2*(tgradU2() && dev(symm(tgradU2())))); - tgradU2.clear(); - - #include "wallFunctions.H" - - // Dissipation equation - fvScalarMatrix epsEqn - ( - fvm::ddt(epsilon) - + fvm::div(phi2, epsilon) - - fvm::Sp(fvc::div(phi2), epsilon) - - fvm::laplacian - ( - alpha1Eps*nuEff2, epsilon, - "laplacian(DepsilonEff,epsilon)" - ) - == - C1*G*epsilon/k - - fvm::Sp(C2*epsilon/k, epsilon) - ); - - #include "wallDissipation.H" - - epsEqn.relax(); - epsEqn.solve(); - - epsilon.max(dimensionedScalar("zero", epsilon.dimensions(), 1.0e-15)); - - - // Turbulent kinetic energy equation - fvScalarMatrix kEqn - ( - fvm::ddt(k) - + fvm::div(phi2, k) - - fvm::Sp(fvc::div(phi2), k) - - fvm::laplacian - ( - alpha1k*nuEff2, k, - "laplacian(DkEff,k)" - ) - == - G - - fvm::Sp(epsilon/k, k) - ); - kEqn.relax(); - kEqn.solve(); - - k.max(dimensionedScalar("zero", k.dimensions(), 1.0e-8)); - - //- Re-calculate turbulence viscosity - nut2 = Cmu*sqr(k)/epsilon; - - #include "wallViscosity.H" -} - -nuEff2 = nut2 + nu2; diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/Make/files b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/Make/files deleted file mode 100644 index 758859e6bb..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/Make/files +++ /dev/null @@ -1,32 +0,0 @@ -kineticTheoryModel/kineticTheoryModel.C - -viscosityModel/viscosityModel/viscosityModel.C -viscosityModel/viscosityModel/newViscosityModel.C -viscosityModel/Gidaspow/GidaspowViscosity.C -viscosityModel/Syamlal/SyamlalViscosity.C -viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C -viscosityModel/none/noneViscosity.C - -conductivityModel/conductivityModel/conductivityModel.C -conductivityModel/conductivityModel/newConductivityModel.C -conductivityModel/Gidaspow/GidaspowConductivity.C -conductivityModel/Syamlal/SyamlalConductivity.C -conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C - -radialModel/radialModel/radialModel.C -radialModel/radialModel/newRadialModel.C -radialModel/CarnahanStarling/CarnahanStarlingRadial.C -radialModel/LunSavage/LunSavageRadial.C -radialModel/SinclairJackson/SinclairJacksonRadial.C - -granularPressureModel/granularPressureModel/granularPressureModel.C -granularPressureModel/granularPressureModel/newGranularPressureModel.C -granularPressureModel/Lun/LunPressure.C -granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C - -frictionalStressModel/frictionalStressModel/frictionalStressModel.C -frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C -frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C -frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C - -LIB = $(FOAM_LIBBIN)/libkineticTheoryModel diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/Make/options b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/Make/options deleted file mode 100644 index 2fcce9913d..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/Make/options +++ /dev/null @@ -1,5 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/foam/lnInclude \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I../phaseModel/lnInclude \ - -I../interfacialModels/lnInclude diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C deleted file mode 100644 index c069b99da0..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C +++ /dev/null @@ -1,83 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "GidaspowConductivity.H" -#include "mathematicalConstants.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(GidaspowConductivity, 0); - - addToRunTimeSelectionTable - ( - conductivityModel, - GidaspowConductivity, - dictionary - ); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::GidaspowConductivity::GidaspowConductivity(const dictionary& dict) -: - conductivityModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::GidaspowConductivity::~GidaspowConductivity() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::GidaspowConductivity::kappa -( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e -) const -{ - const scalar sqrtPi = sqrt(constant::mathematical::pi); - - return rho1*da*sqrt(Theta)* - ( - 2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi - + (9.0/8.0)*sqrtPi*g0*0.5*(1.0 + e)*sqr(alpha1) - + (15.0/16.0)*sqrtPi*alpha1 - + (25.0/64.0)*sqrtPi/((1.0 + e)*g0) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H deleted file mode 100644 index 40119b7539..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H +++ /dev/null @@ -1,91 +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 . - -Class - Foam::GidaspowConductivity - -Description - -SourceFiles - GidaspowConductivity.C - -\*---------------------------------------------------------------------------*/ - -#ifndef GidaspowConductivity_H -#define GidaspowConductivity_H - -#include "conductivityModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class GidaspowConductivity Declaration -\*---------------------------------------------------------------------------*/ - -class GidaspowConductivity -: - public conductivityModel -{ - -public: - - //- Runtime type information - TypeName("Gidaspow"); - - - // Constructors - - //- Construct from components - GidaspowConductivity(const dictionary& dict); - - - //- Destructor - virtual ~GidaspowConductivity(); - - - // Member Functions - - tmp kappa - ( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C deleted file mode 100644 index 9cc0328284..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C +++ /dev/null @@ -1,96 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "HrenyaSinclairConductivity.H" -#include "mathematicalConstants.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(HrenyaSinclairConductivity, 0); - - addToRunTimeSelectionTable - ( - conductivityModel, - HrenyaSinclairConductivity, - dictionary - ); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::HrenyaSinclairConductivity::HrenyaSinclairConductivity -( - const dictionary& dict -) -: - conductivityModel(dict), - coeffsDict_(dict.subDict(typeName + "Coeffs")), - L_(coeffsDict_.lookup("L")) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::HrenyaSinclairConductivity::~HrenyaSinclairConductivity() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::HrenyaSinclairConductivity::kappa -( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e -) const -{ - const scalar sqrtPi = sqrt(constant::mathematical::pi); - - volScalarField lamda - ( - scalar(1) + da/(6.0*sqrt(2.0)*(alpha1 + scalar(1.0e-5)))/L_ - ); - - return rho1*da*sqrt(Theta)* - ( - 2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi - + (9.0/8.0)*sqrtPi*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1) - /(49.0/16.0 - 33.0*e/16.0) - + (15.0/16.0)*sqrtPi*alpha1*(0.5*sqr(e) + 0.25*e - 0.75 + lamda) - /((49.0/16.0 - 33.0*e/16.0)*lamda) - + (25.0/64.0)*sqrtPi - /((1.0 + e)*(49.0/16.0 - 33.0*e/16.0)*lamda*g0) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H deleted file mode 100644 index b5004459f3..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H +++ /dev/null @@ -1,96 +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 . - -Class - Foam::HrenyaSinclairConductivity - -Description - -SourceFiles - HrenyaSinclairConductivity.C - -\*---------------------------------------------------------------------------*/ - -#ifndef HrenyaSinclairConductivity_H -#define HrenyaSinclairConductivity_H - -#include "conductivityModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class HrenyaSinclairConductivity Declaration -\*---------------------------------------------------------------------------*/ - -class HrenyaSinclairConductivity -: - public conductivityModel -{ - - dictionary coeffsDict_; - - //- characteristic length of geometry - dimensionedScalar L_; - -public: - - //- Runtime type information - TypeName("HrenyaSinclair"); - - - // Constructors - - //- Construct from components - HrenyaSinclairConductivity(const dictionary& dict); - - - //- Destructor - virtual ~HrenyaSinclairConductivity(); - - - // Member Functions - - tmp kappa - ( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C deleted file mode 100644 index 99d9515f89..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C +++ /dev/null @@ -1,83 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "SyamlalConductivity.H" -#include "mathematicalConstants.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(SyamlalConductivity, 0); - - addToRunTimeSelectionTable - ( - conductivityModel, - SyamlalConductivity, - dictionary - ); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::SyamlalConductivity::SyamlalConductivity(const dictionary& dict) -: - conductivityModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::SyamlalConductivity::~SyamlalConductivity() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::SyamlalConductivity::kappa -( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e -) const -{ - const scalar sqrtPi = sqrt(constant::mathematical::pi); - - return rho1*da*sqrt(Theta)* - ( - 2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi - + (9.0/8.0)*sqrtPi*g0*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1) - /(49.0/16.0 - 33.0*e/16.0) - + (15.0/32.0)*sqrtPi*alpha1/(49.0/16.0 - 33.0*e/16.0) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C deleted file mode 100644 index 3452bb713b..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C +++ /dev/null @@ -1,55 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "conductivityModel.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(conductivityModel, 0); - - defineRunTimeSelectionTable(conductivityModel, dictionary); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::conductivityModel::conductivityModel -( - const dictionary& dict -) -: - dict_(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::conductivityModel::~conductivityModel() -{} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H deleted file mode 100644 index 885f710599..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H +++ /dev/null @@ -1,125 +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 . - -Class - Foam::conductivityModel - -SourceFiles - conductivityModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef conductivityModel_H -#define conductivityModel_H - -#include "dictionary.H" -#include "volFields.H" -#include "dimensionedTypes.H" -#include "runTimeSelectionTables.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class conductivityModel Declaration -\*---------------------------------------------------------------------------*/ - -class conductivityModel -{ - // Private member functions - - //- Disallow default bitwise copy construct - conductivityModel(const conductivityModel&); - - //- Disallow default bitwise assignment - void operator=(const conductivityModel&); - - -protected: - - // Protected data - - const dictionary& dict_; - - -public: - - //- Runtime type information - TypeName("conductivityModel"); - - // Declare runtime constructor selection table - declareRunTimeSelectionTable - ( - autoPtr, - conductivityModel, - dictionary, - ( - const dictionary& dict - ), - (dict) - ); - - - // Constructors - - //- Construct from components - conductivityModel(const dictionary& dict); - - - // Selectors - - static autoPtr New - ( - const dictionary& dict - ); - - - //- Destructor - virtual ~conductivityModel(); - - - // Member Functions - - virtual tmp kappa - ( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e - ) const = 0; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C deleted file mode 100644 index 93ed0bac1b..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C +++ /dev/null @@ -1,58 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "conductivityModel.H" - -// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * // - -Foam::autoPtr Foam::conductivityModel::New -( - const dictionary& dict -) -{ - word conductivityModelType(dict.lookup("conductivityModel")); - - Info<< "Selecting conductivityModel " - << conductivityModelType << endl; - - dictionaryConstructorTable::iterator cstrIter = - dictionaryConstructorTablePtr_->find(conductivityModelType); - - if (cstrIter == dictionaryConstructorTablePtr_->end()) - { - FatalError - << "conductivityModel::New(const dictionary&) : " << endl - << " unknown conductivityModelType type " - << conductivityModelType - << ", constructor not in hash table" << endl << endl - << " Valid conductivityModelType types are :" << endl; - Info<< dictionaryConstructorTablePtr_->sortedToc() << abort(FatalError); - } - - return autoPtr(cstrIter()(dict)); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C deleted file mode 100644 index 7ab6f06f0d..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C +++ /dev/null @@ -1,114 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "JohnsonJacksonFrictionalStress.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(JohnsonJacksonFrictionalStress, 0); - - addToRunTimeSelectionTable - ( - frictionalStressModel, - JohnsonJacksonFrictionalStress, - dictionary - ); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::JohnsonJacksonFrictionalStress::JohnsonJacksonFrictionalStress -( - const dictionary& dict -) -: - frictionalStressModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::JohnsonJacksonFrictionalStress::~JohnsonJacksonFrictionalStress() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::JohnsonJacksonFrictionalStress:: -frictionalPressure -( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p -) const -{ - - return - Fr*pow(max(alpha1 - alphaMinFriction, scalar(0)), eta) - /pow(max(alphaMax - alpha1, scalar(5.0e-2)), p); -} - - -Foam::tmp Foam::JohnsonJacksonFrictionalStress:: -frictionalPressurePrime -( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p -) const -{ - return Fr* - ( - eta*pow(max(alpha1 - alphaMinFriction, scalar(0)), eta - 1.0) - *(alphaMax-alpha1) - + p*pow(max(alpha1 - alphaMinFriction, scalar(0)), eta) - )/pow(max(alphaMax - alpha1, scalar(5.0e-2)), p + 1.0); -} - - -Foam::tmp Foam::JohnsonJacksonFrictionalStress::muf -( - const volScalarField& alpha1, - const dimensionedScalar& alphaMax, - const volScalarField& pf, - const volSymmTensorField& D, - const dimensionedScalar& phi -) const -{ - return dimensionedScalar("0.5", dimTime, 0.5)*pf*sin(phi); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H deleted file mode 100644 index 91f480b4ea..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H +++ /dev/null @@ -1,110 +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 . - -Class - Foam::JohnsonJacksonFrictionalStress - -Description - -SourceFiles - JohnsonJacksonFrictionalStress.C - -\*---------------------------------------------------------------------------*/ - -#ifndef JohnsonJacksonFrictionalStress_H -#define JohnsonJacksonFrictionalStress_H - -#include "frictionalStressModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class JohnsonJacksonFrictionalStress Declaration -\*---------------------------------------------------------------------------*/ - -class JohnsonJacksonFrictionalStress -: - public frictionalStressModel -{ - -public: - - //- Runtime type information - TypeName("JohnsonJackson"); - - - // Constructors - - //- Construct from components - JohnsonJacksonFrictionalStress(const dictionary& dict); - - - //- Destructor - virtual ~JohnsonJacksonFrictionalStress(); - - - // Member functions - - virtual tmp frictionalPressure - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p - ) const; - - virtual tmp frictionalPressurePrime - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p - ) const; - - virtual tmp muf - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMax, - const volScalarField& pf, - const volSymmTensorField& D, - const dimensionedScalar& phi - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C deleted file mode 100644 index 73b2cc57ee..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C +++ /dev/null @@ -1,149 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "SchaefferFrictionalStress.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(SchaefferFrictionalStress, 0); - - addToRunTimeSelectionTable - ( - frictionalStressModel, - SchaefferFrictionalStress, - dictionary - ); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::SchaefferFrictionalStress::SchaefferFrictionalStress -( - const dictionary& dict -) -: - frictionalStressModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::SchaefferFrictionalStress::~SchaefferFrictionalStress() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::SchaefferFrictionalStress:: -frictionalPressure -( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p -) const -{ - return - dimensionedScalar("1e24", dimensionSet(1, -1, -2, 0, 0), 1e24) - *pow(Foam::max(alpha1 - alphaMinFriction, scalar(0)), 10.0); -} - - -Foam::tmp Foam::SchaefferFrictionalStress:: -frictionalPressurePrime -( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p -) const -{ - return - dimensionedScalar("1e25", dimensionSet(1, -1, -2, 0, 0), 1e25) - *pow(Foam::max(alpha1 - alphaMinFriction, scalar(0)), 9.0); -} - - -Foam::tmp Foam::SchaefferFrictionalStress::muf -( - const volScalarField& alpha1, - const dimensionedScalar& alphaMax, - const volScalarField& pf, - const volSymmTensorField& D, - const dimensionedScalar& phi -) const -{ - const scalar I2Dsmall = 1.0e-15; - - // Creating muf assuming it should be 0 on the boundary which may not be - // true - tmp tmuf - ( - new volScalarField - ( - IOobject - ( - "muf", - alpha1.mesh().time().timeName(), - alpha1.mesh() - ), - alpha1.mesh(), - dimensionedScalar("muf", dimensionSet(1, -1, -1, 0, 0), 0.0) - ) - ); - - volScalarField& muff = tmuf(); - - forAll (D, celli) - { - if (alpha1[celli] > alphaMax.value() - 5e-2) - { - muff[celli] = - 0.5*pf[celli]*sin(phi.value()) - /( - sqrt(1.0/6.0*(sqr(D[celli].xx() - D[celli].yy()) - + sqr(D[celli].yy() - D[celli].zz()) - + sqr(D[celli].zz() - D[celli].xx())) - + sqr(D[celli].xy()) + sqr(D[celli].xz()) - + sqr(D[celli].yz())) + I2Dsmall - ); - } - } - - muff.correctBoundaryConditions(); - - return tmuf; -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H deleted file mode 100644 index d74b0d9127..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H +++ /dev/null @@ -1,110 +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 . - -Class - Foam::SchaefferFrictionalStress - -Description - -SourceFiles - SchaefferFrictionalStress.C - -\*---------------------------------------------------------------------------*/ - -#ifndef SchaefferFrictionalStress_H -#define SchaefferFrictionalStress_H - -#include "frictionalStressModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class SchaefferFrictionalStress Declaration -\*---------------------------------------------------------------------------*/ - -class SchaefferFrictionalStress -: - public frictionalStressModel -{ - -public: - - //- Runtime type information - TypeName("Schaeffer"); - - - // Constructors - - //- Construct from components - SchaefferFrictionalStress(const dictionary& dict); - - - //- Destructor - virtual ~SchaefferFrictionalStress(); - - - // Member functions - - virtual tmp frictionalPressure - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p - ) const; - - virtual tmp frictionalPressurePrime - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& n, - const dimensionedScalar& p - ) const; - - virtual tmp muf - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMax, - const volScalarField& pf, - const volSymmTensorField& D, - const dimensionedScalar& phi - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H deleted file mode 100644 index 2242aa4224..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H +++ /dev/null @@ -1,144 +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 . - -Class - Foam::frictionalStressModel - -SourceFiles - frictionalStressModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef frictionalStressModel_H -#define frictionalStressModel_H - -#include "dictionary.H" -#include "volFields.H" -#include "dimensionedTypes.H" -#include "runTimeSelectionTables.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class frictionalStressModel Declaration -\*---------------------------------------------------------------------------*/ - -class frictionalStressModel -{ - // Private member functions - - //- Disallow default bitwise copy construct - frictionalStressModel(const frictionalStressModel&); - - //- Disallow default bitwise assignment - void operator=(const frictionalStressModel&); - - -protected: - - // Protected data - - const dictionary& dict_; - - -public: - - //- Runtime type information - TypeName("frictionalStressModel"); - - // Declare runtime constructor selection table - declareRunTimeSelectionTable - ( - autoPtr, - frictionalStressModel, - dictionary, - ( - const dictionary& dict - ), - (dict) - ); - - - // Constructors - - //- Construct from components - frictionalStressModel(const dictionary& dict); - - - // Selectors - - static autoPtr New - ( - const dictionary& dict - ); - - - //- Destructor - virtual ~frictionalStressModel(); - - - // Member Functions - - virtual tmp frictionalPressure - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p - ) const = 0; - - virtual tmp frictionalPressurePrime - ( - const volScalarField& alpha1f, - const dimensionedScalar& alphaMinFriction, - const dimensionedScalar& alphaMax, - const dimensionedScalar& Fr, - const dimensionedScalar& eta, - const dimensionedScalar& p - ) const = 0; - - virtual tmp muf - ( - const volScalarField& alpha1, - const dimensionedScalar& alphaMax, - const volScalarField& pf, - const volSymmTensorField& D, - const dimensionedScalar& phi - ) const = 0; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C deleted file mode 100644 index e9d8b9230c..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C +++ /dev/null @@ -1,59 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "frictionalStressModel.H" - -// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * // - -Foam::autoPtr Foam::frictionalStressModel::New -( - const dictionary& dict -) -{ - word frictionalStressModelType(dict.lookup("frictionalStressModel")); - - Info<< "Selecting frictionalStressModel " - << frictionalStressModelType << endl; - - dictionaryConstructorTable::iterator cstrIter = - dictionaryConstructorTablePtr_->find(frictionalStressModelType); - - if (cstrIter == dictionaryConstructorTablePtr_->end()) - { - FatalError - << "frictionalStressModel::New(const dictionary&) : " << endl - << " unknown frictionalStressModelType type " - << frictionalStressModelType - << ", constructor not in hash table" << endl << endl - << " Valid frictionalStressModelType types are :" << endl; - Info<< dictionaryConstructorTablePtr_->sortedToc() - << abort(FatalError); - } - - return autoPtr(cstrIter()(dict)); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C deleted file mode 100644 index abd0be0647..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C +++ /dev/null @@ -1,85 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "LunPressure.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(LunPressure, 0); - - addToRunTimeSelectionTable - ( - granularPressureModel, - LunPressure, - dictionary - ); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::LunPressure::LunPressure(const dictionary& dict) -: - granularPressureModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::LunPressure::~LunPressure() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::LunPressure::granularPressureCoeff -( - const volScalarField& alpha1, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& e -) const -{ - - return rho1*alpha1*(1.0 + 2.0*(1.0 + e)*alpha1*g0); -} - - -Foam::tmp Foam::LunPressure::granularPressureCoeffPrime -( - const volScalarField& alpha1, - const volScalarField& g0, - const volScalarField& g0prime, - const dimensionedScalar& rho1, - const dimensionedScalar& e -) const -{ - return rho1*(1.0 + alpha1*(1.0 + e)*(4.0*g0 + 2.0*g0prime*alpha1)); -} - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H deleted file mode 100644 index e67df01b9a..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H +++ /dev/null @@ -1,98 +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 . - -Class - Foam::LunPressure - -Description - -SourceFiles - LunPressure.C - -\*---------------------------------------------------------------------------*/ - -#ifndef LunPressure_H -#define LunPressure_H - -#include "granularPressureModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class LunPressure Declaration -\*---------------------------------------------------------------------------*/ - -class LunPressure -: - public granularPressureModel -{ - -public: - - //- Runtime type information - TypeName("Lun"); - - - // Constructors - - //- Construct from components - LunPressure(const dictionary& dict); - - - //- Destructor - virtual ~LunPressure(); - - - // Member Functions - - tmp granularPressureCoeff - ( - const volScalarField& alpha1, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& e - ) const; - - tmp granularPressureCoeffPrime - ( - const volScalarField& alpha1, - const volScalarField& g0, - const volScalarField& g0prime, - const dimensionedScalar& rho1, - const dimensionedScalar& e - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C deleted file mode 100644 index 0f676cd08e..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C +++ /dev/null @@ -1,91 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "SyamlalRogersOBrienPressure.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(SyamlalRogersOBrienPressure, 0); - - addToRunTimeSelectionTable - ( - granularPressureModel, - SyamlalRogersOBrienPressure, - dictionary - ); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::SyamlalRogersOBrienPressure::SyamlalRogersOBrienPressure -( - const dictionary& dict -) -: - granularPressureModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::SyamlalRogersOBrienPressure::~SyamlalRogersOBrienPressure() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::SyamlalRogersOBrienPressure:: -granularPressureCoeff -( - const volScalarField& alpha1, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& e -) const -{ - - return 2.0*rho1*(1.0 + e)*sqr(alpha1)*g0; -} - - -Foam::tmp Foam::SyamlalRogersOBrienPressure:: -granularPressureCoeffPrime -( - const volScalarField& alpha1, - const volScalarField& g0, - const volScalarField& g0prime, - const dimensionedScalar& rho1, - const dimensionedScalar& e -) const -{ - return rho1*alpha1*(1.0 + e)*(4.0*g0 + 2.0*g0prime*alpha1); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H deleted file mode 100644 index e9d697a322..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H +++ /dev/null @@ -1,98 +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 . - -Class - Foam::SyamlalRogersOBrienPressure - -Description - -SourceFiles - SyamlalRogersOBrienPressure.C - -\*---------------------------------------------------------------------------*/ - -#ifndef SyamlalRogersOBrienPressure_H -#define SyamlalRogersOBrienPressure_H - -#include "granularPressureModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class SyamlalRogersOBrienPressure Declaration -\*---------------------------------------------------------------------------*/ - -class SyamlalRogersOBrienPressure -: - public granularPressureModel -{ - -public: - - //- Runtime type information - TypeName("SyamlalRogersOBrien"); - - - // Constructors - - //- Construct from components - SyamlalRogersOBrienPressure(const dictionary& dict); - - - //- Destructor - virtual ~SyamlalRogersOBrienPressure(); - - - // Member Functions - - tmp granularPressureCoeff - ( - const volScalarField& alpha1, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& e - ) const; - - tmp granularPressureCoeffPrime - ( - const volScalarField& alpha1, - const volScalarField& g0, - const volScalarField& g0prime, - const dimensionedScalar& rho1, - const dimensionedScalar& e - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C deleted file mode 100644 index 903a8183c9..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C +++ /dev/null @@ -1,55 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "granularPressureModel.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - defineTypeNameAndDebug(granularPressureModel, 0); - - defineRunTimeSelectionTable(granularPressureModel, dictionary); -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::granularPressureModel::granularPressureModel -( - const dictionary& dict -) -: - dict_(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::granularPressureModel::~granularPressureModel() -{} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H deleted file mode 100644 index a60f83565f..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H +++ /dev/null @@ -1,134 +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 . - -Class - Foam::granularPressureModel - -SourceFiles - granularPressureModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef granularPressureModel_H -#define granularPressureModel_H - -#include "dictionary.H" -#include "volFields.H" -#include "dimensionedTypes.H" -#include "runTimeSelectionTables.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class granularPressureModel Declaration -\*---------------------------------------------------------------------------*/ - -class granularPressureModel -{ - // Private member functions - - //- Disallow default bitwise copy construct - granularPressureModel(const granularPressureModel&); - - //- Disallow default bitwise assignment - void operator=(const granularPressureModel&); - - -protected: - - // Protected data - - const dictionary& dict_; - - -public: - - //- Runtime type information - TypeName("granularPressureModel"); - - // Declare runtime constructor selection table - declareRunTimeSelectionTable - ( - autoPtr, - granularPressureModel, - dictionary, - ( - const dictionary& dict - ), - (dict) - ); - - - // Constructors - - //- Construct from components - granularPressureModel(const dictionary& dict); - - - // Selectors - - static autoPtr New - ( - const dictionary& dict - ); - - - //- Destructor - virtual ~granularPressureModel(); - - - // Member Functions - - //- Granular pressure coefficient - virtual tmp granularPressureCoeff - ( - const volScalarField& alpha1, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& e - ) const = 0; - - //- Derivative of the granular pressure coefficient - virtual tmp granularPressureCoeffPrime - ( - const volScalarField& alpha1, - const volScalarField& g0, - const volScalarField& g0prime, - const dimensionedScalar& rho1, - const dimensionedScalar& e - ) const = 0; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C deleted file mode 100644 index 5ad8ea0ab5..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C +++ /dev/null @@ -1,59 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "granularPressureModel.H" - -// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * // - -Foam::autoPtr Foam::granularPressureModel::New -( - const dictionary& dict -) -{ - word granularPressureModelType(dict.lookup("granularPressureModel")); - - Info<< "Selecting granularPressureModel " - << granularPressureModelType << endl; - - dictionaryConstructorTable::iterator cstrIter = - dictionaryConstructorTablePtr_->find(granularPressureModelType); - - if (cstrIter == dictionaryConstructorTablePtr_->end()) - { - FatalError - << "granularPressureModel::New(const dictionary&) : " << endl - << " unknown granularPressureModelType type " - << granularPressureModelType - << ", constructor not in hash table" << endl << endl - << " Valid granularPressureModelType types are :" << endl; - Info<< dictionaryConstructorTablePtr_->sortedToc() - << abort(FatalError); - } - - return autoPtr(cstrIter()(dict)); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C deleted file mode 100644 index 5a27c288da..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C +++ /dev/null @@ -1,389 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "kineticTheoryModel.H" -#include "surfaceInterpolate.H" -#include "mathematicalConstants.H" -#include "fvCFD.H" - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModel::kineticTheoryModel -( - const Foam::phaseModel& phase1, - const Foam::volVectorField& U2, - const Foam::volScalarField& alpha1, - const Foam::dragModel& drag1 -) -: - phase1_(phase1), - U1_(phase1.U()), - U2_(U2), - alpha1_(alpha1), - phi1_(phase1.phi()), - drag1_(drag1), - - rho1_(phase1.rho()), - da_(phase1.d()), - nu1_(phase1.nu()), - - kineticTheoryProperties_ - ( - IOobject - ( - "kineticTheoryProperties", - U1_.time().constant(), - U1_.mesh(), - IOobject::MUST_READ, - IOobject::NO_WRITE - ) - ), - kineticTheory_(kineticTheoryProperties_.lookup("kineticTheory")), - equilibrium_(kineticTheoryProperties_.lookup("equilibrium")), - - viscosityModel_ - ( - kineticTheoryModels::viscosityModel::New - ( - kineticTheoryProperties_ - ) - ), - conductivityModel_ - ( - conductivityModel::New - ( - kineticTheoryProperties_ - ) - ), - radialModel_ - ( - kineticTheoryModels::radialModel::New - ( - kineticTheoryProperties_ - ) - ), - granularPressureModel_ - ( - granularPressureModel::New - ( - kineticTheoryProperties_ - ) - ), - frictionalStressModel_ - ( - frictionalStressModel::New - ( - kineticTheoryProperties_ - ) - ), - e_(kineticTheoryProperties_.lookup("e")), - alphaMax_(kineticTheoryProperties_.lookup("alphaMax")), - alphaMinFriction_(kineticTheoryProperties_.lookup("alphaMinFriction")), - Fr_(kineticTheoryProperties_.lookup("Fr")), - eta_(kineticTheoryProperties_.lookup("eta")), - p_(kineticTheoryProperties_.lookup("p")), - phi_(dimensionedScalar(kineticTheoryProperties_.lookup("phi"))*M_PI/180.0), - Theta_ - ( - IOobject - ( - "Theta", - U1_.time().timeName(), - U1_.mesh(), - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - U1_.mesh() - ), - mu1_ - ( - IOobject - ( - "mu1", - U1_.time().timeName(), - U1_.mesh(), - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - U1_.mesh(), - dimensionedScalar("zero", dimensionSet(1, -1, -1, 0, 0), 0.0) - ), - lambda_ - ( - IOobject - ( - "lambda", - U1_.time().timeName(), - U1_.mesh(), - IOobject::NO_READ, - IOobject::NO_WRITE - ), - U1_.mesh(), - dimensionedScalar("zero", dimensionSet(1, -1, -1, 0, 0), 0.0) - ), - pa_ - ( - IOobject - ( - "pa", - U1_.time().timeName(), - U1_.mesh(), - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - U1_.mesh(), - dimensionedScalar("zero", dimensionSet(1, -1, -2, 0, 0), 0.0) - ), - kappa_ - ( - IOobject - ( - "kappa", - U1_.time().timeName(), - U1_.mesh(), - IOobject::NO_READ, - IOobject::NO_WRITE - ), - U1_.mesh(), - dimensionedScalar("zero", dimensionSet(1, -1, -1, 0, 0), 0.0) - ), - gs0_ - ( - IOobject - ( - "gs0", - U1_.time().timeName(), - U1_.mesh(), - IOobject::NO_READ, - IOobject::NO_WRITE - ), - U1_.mesh(), - dimensionedScalar("zero", dimensionSet(0, 0, 0, 0, 0), 1.0) - ) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModel::~kineticTheoryModel() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -void Foam::kineticTheoryModel::solve(const volTensorField& gradU1t) -{ - if (!kineticTheory_) - { - return; - } - - const scalar sqrtPi = sqrt(constant::mathematical::pi); - - surfaceScalarField phi(1.5*rho1_*phi1_*fvc::interpolate(alpha1_)); - - volTensorField dU(gradU1t.T()); //fvc::grad(U1_); - volSymmTensorField D(symm(dU)); - - // NB, drag = K*alpha1*alpha2, - // (the alpha1 and alpha2 has been extracted from the drag function for - // numerical reasons) - volScalarField Ur(mag(U1_ - U2_)); - volScalarField alpha2Prim(alpha1_*(1.0 - alpha1_)*drag1_.K(Ur)); - - // Calculating the radial distribution function (solid volume fraction is - // limited close to the packing limit, but this needs improvements) - // The solution is higly unstable close to the packing limit. - gs0_ = radialModel_->g0 - ( - min(max(alpha1_, scalar(1e-6)), alphaMax_ - 0.01), - alphaMax_ - ); - - // particle pressure - coefficient in front of Theta (Eq. 3.22, p. 45) - volScalarField PsCoeff - ( - granularPressureModel_->granularPressureCoeff - ( - alpha1_, - gs0_, - rho1_, - e_ - ) - ); - - // 'thermal' conductivity (Table 3.3, p. 49) - kappa_ = conductivityModel_->kappa(alpha1_, Theta_, gs0_, rho1_, da_, e_); - - // particle viscosity (Table 3.2, p.47) - mu1_ = viscosityModel_->mu1(alpha1_, Theta_, gs0_, rho1_, da_, e_); - - dimensionedScalar Tsmall - ( - "small", - dimensionSet(0 , 2 ,-2 ,0 , 0, 0, 0), - 1.0e-6 - ); - - dimensionedScalar TsmallSqrt = sqrt(Tsmall); - volScalarField ThetaSqrt(sqrt(Theta_)); - - // dissipation (Eq. 3.24, p.50) - volScalarField gammaCoeff - ( - 12.0*(1.0 - sqr(e_))*sqr(alpha1_)*rho1_*gs0_*(1.0/da_)*ThetaSqrt/sqrtPi - ); - - // Eq. 3.25, p. 50 Js = J1 - J2 - volScalarField J1(3.0*alpha2Prim); - volScalarField J2 - ( - 0.25*sqr(alpha2Prim)*da_*sqr(Ur) - /(max(alpha1_, scalar(1e-6))*rho1_*sqrtPi*(ThetaSqrt + TsmallSqrt)) - ); - - // bulk viscosity p. 45 (Lun et al. 1984). - lambda_ = (4.0/3.0)*sqr(alpha1_)*rho1_*da_*gs0_*(1.0+e_)*ThetaSqrt/sqrtPi; - - // stress tensor, Definitions, Table 3.1, p. 43 - volSymmTensorField tau(2.0*mu1_*D + (lambda_ - (2.0/3.0)*mu1_)*tr(D)*I); - - if (!equilibrium_) - { - // construct the granular temperature equation (Eq. 3.20, p. 44) - // NB. note that there are two typos in Eq. 3.20 - // no grad infront of Ps - // wrong sign infront of laplacian - fvScalarMatrix ThetaEqn - ( - fvm::ddt(1.5*alpha1_*rho1_, Theta_) - + fvm::div(phi, Theta_, "div(phi,Theta)") - == - fvm::SuSp(-((PsCoeff*I) && dU), Theta_) - + (tau && dU) - + fvm::laplacian(kappa_, Theta_, "laplacian(kappa,Theta)") - + fvm::Sp(-gammaCoeff, Theta_) - + fvm::Sp(-J1, Theta_) - + fvm::Sp(J2/(Theta_ + Tsmall), Theta_) - ); - - ThetaEqn.relax(); - ThetaEqn.solve(); - } - else - { - // equilibrium => dissipation == production - // Eq. 4.14, p.82 - volScalarField K1(2.0*(1.0 + e_)*rho1_*gs0_); - volScalarField K3 - ( - 0.5*da_*rho1_* - ( - (sqrtPi/(3.0*(3.0-e_))) - *(1.0 + 0.4*(1.0 + e_)*(3.0*e_ - 1.0)*alpha1_*gs0_) - +1.6*alpha1_*gs0_*(1.0 + e_)/sqrtPi - ) - ); - - volScalarField K2 - ( - 4.0*da_*rho1_*(1.0 + e_)*alpha1_*gs0_/(3.0*sqrtPi) - 2.0*K3/3.0 - ); - - volScalarField K4(12.0*(1.0 - sqr(e_))*rho1_*gs0_/(da_*sqrtPi)); - - volScalarField trD(tr(D)); - volScalarField tr2D(sqr(trD)); - volScalarField trD2(tr(D & D)); - - volScalarField t1(K1*alpha1_ + rho1_); - volScalarField l1(-t1*trD); - volScalarField l2(sqr(t1)*tr2D); - volScalarField l3 - ( - 4.0 - *K4 - *max(alpha1_, scalar(1e-6)) - *(2.0*K3*trD2 + K2*tr2D) - ); - - Theta_ = sqr((l1 + sqrt(l2 + l3))/(2.0*(alpha1_ + 1.0e-4)*K4)); - } - - Theta_.max(1.0e-15); - Theta_.min(1.0e+3); - - volScalarField pf - ( - frictionalStressModel_->frictionalPressure - ( - alpha1_, - alphaMinFriction_, - alphaMax_, - Fr_, - eta_, - p_ - ) - ); - - PsCoeff += pf/(Theta_+Tsmall); - - PsCoeff.min(1.0e+10); - PsCoeff.max(-1.0e+10); - - // update particle pressure - pa_ = PsCoeff*Theta_; - - // frictional shear stress, Eq. 3.30, p. 52 - volScalarField muf - ( - frictionalStressModel_->muf - ( - alpha1_, - alphaMax_, - pf, - D, - phi_ - ) - ); - - // add frictional stress - mu1_ += muf; - mu1_.min(1.0e+2); - mu1_.max(0.0); - - Info<< "kinTheory: max(Theta) = " << max(Theta_).value() << endl; - - volScalarField ktn(mu1_/rho1_); - - Info<< "kinTheory: min(nu1) = " << min(ktn).value() - << ", max(nu1) = " << max(ktn).value() << endl; - - Info<< "kinTheory: min(pa) = " << min(pa_).value() - << ", max(pa) = " << max(pa_).value() << endl; -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H deleted file mode 100644 index 28ae38a9db..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H +++ /dev/null @@ -1,196 +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 . - -Class - Foam::kineticTheoryModel - -Description - -SourceFiles - kineticTheoryModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef kineticTheoryModel_H -#define kineticTheoryModel_H - -#include "dragModel.H" -#include "phaseModel.H" -#include "autoPtr.H" -#include "viscosityModel.H" -#include "conductivityModel.H" -#include "radialModel.H" -#include "granularPressureModel.H" -#include "frictionalStressModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class kineticTheoryModel Declaration -\*---------------------------------------------------------------------------*/ - -class kineticTheoryModel -{ - // Private data - - const phaseModel& phase1_; - const volVectorField& U1_; - const volVectorField& U2_; - const volScalarField& alpha1_; - const surfaceScalarField& phi1_; - - const dragModel& drag1_; - - const dimensionedScalar& rho1_; - const dimensionedScalar& da_; - const dimensionedScalar& nu1_; - - //- dictionary holding the modeling info - IOdictionary kineticTheoryProperties_; - - //- use kinetic theory or not. - Switch kineticTheory_; - - //- use generation == dissipation - Switch equilibrium_; - - autoPtr viscosityModel_; - - autoPtr conductivityModel_; - - autoPtr radialModel_; - - autoPtr granularPressureModel_; - - autoPtr frictionalStressModel_; - - //- coefficient of restitution - const dimensionedScalar e_; - - //- maximum packing - const dimensionedScalar alphaMax_; - - //- min value for which the frictional stresses are zero - const dimensionedScalar alphaMinFriction_; - - //- material constant for frictional normal stress - const dimensionedScalar Fr_; - - //- material constant for frictional normal stress - const dimensionedScalar eta_; - - //- material constant for frictional normal stress - const dimensionedScalar p_; - - //- angle of internal friction - const dimensionedScalar phi_; - - //- The granular energy/temperature - volScalarField Theta_; - - //- The granular viscosity - volScalarField mu1_; - - //- The granular bulk viscosity - volScalarField lambda_; - - //- The granular pressure - volScalarField pa_; - - //- The granular temperature conductivity - volScalarField kappa_; - - //- The radial distribution function - volScalarField gs0_; - - - // Private Member Functions - - //- Disallow default bitwise copy construct - kineticTheoryModel(const kineticTheoryModel&); - - //- Disallow default bitwise assignment - void operator=(const kineticTheoryModel&); - - -public: - - // Constructors - - //- Construct from components - kineticTheoryModel - ( - const phaseModel& phase1, - const volVectorField& U2, - const volScalarField& alpha1, - const dragModel& drag1 - ); - - - //- Destructor - virtual ~kineticTheoryModel(); - - - // Member Functions - - void solve(const volTensorField& gradU1t); - - bool on() const - { - return kineticTheory_; - } - - const volScalarField& mu1() const - { - return mu1_; - } - - const volScalarField& pa() const - { - return pa_; - } - - const volScalarField& lambda() const - { - return lambda_; - } - - const volScalarField& kappa() const - { - return kappa_; - } -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C deleted file mode 100644 index cfe74982a8..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C +++ /dev/null @@ -1,98 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "CarnahanStarlingRadial.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ -namespace radialModels -{ - defineTypeNameAndDebug(CarnahanStarling, 0); - - addToRunTimeSelectionTable - ( - radialModel, - CarnahanStarling, - dictionary - ); -} -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModels::CarnahanStarling::CarnahanStarling -( - const dictionary& dict -) -: - radialModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModels::CarnahanStarling::~CarnahanStarling() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp -Foam::kineticTheoryModels::radialModels::CarnahanStarling::g0 -( - const volScalarField& alpha, - const dimensionedScalar& alphaMax -) const -{ - - return - 1.0/(1.0 - alpha) - + 3.0*alpha/(2.0*sqr(1.0 - alpha)) - + sqr(alpha)/(2.0*pow(1.0 - alpha, 3)); -} - - -Foam::tmp -Foam::kineticTheoryModels::radialModels::CarnahanStarling::g0prime -( - const volScalarField& alpha, - const dimensionedScalar& alphaMax -) const -{ - return - 2.5/sqr(1.0 - alpha) - + 4.0*alpha/pow(1.0 - alpha, 3.0) - + 1.5*sqr(alpha)/pow(1.0 - alpha, 4.0); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H deleted file mode 100644 index ee61b18099..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H +++ /dev/null @@ -1,100 +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 . - -Class - Foam::kineticTheoryModels::radialModels::CarnahanStarling - -Description - -SourceFiles - CarnahanStarlingRadial.C - -\*---------------------------------------------------------------------------*/ - -#ifndef CarnahanStarling_H -#define CarnahanStarling_H - -#include "radialModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ -namespace radialModels -{ - -/*---------------------------------------------------------------------------*\ - Class CarnahanStarling Declaration -\*---------------------------------------------------------------------------*/ - -class CarnahanStarling -: - public radialModel -{ - -public: - - //- Runtime type information - TypeName("CarnahanStarling"); - - - // Constructors - - //- Construct from components - CarnahanStarling(const dictionary& dict); - - - //- Destructor - virtual ~CarnahanStarling(); - - - // Member Functions - - - tmp g0 - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const; - - tmp g0prime - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace radialModels -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C deleted file mode 100644 index 9f029288dd..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C +++ /dev/null @@ -1,92 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "LunSavageRadial.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ -namespace radialModels -{ - defineTypeNameAndDebug(LunSavage, 0); - - addToRunTimeSelectionTable - ( - radialModel, - LunSavage, - dictionary - ); -} -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModels::LunSavage::LunSavage -( - const dictionary& dict -) -: - radialModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModels::LunSavage::~LunSavage() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp -Foam::kineticTheoryModels::radialModels::LunSavage::g0 -( - const volScalarField& alpha, - const dimensionedScalar& alphaMax -) const -{ - - return pow(1.0 - alpha/alphaMax, -2.5*alphaMax); -} - - -Foam::tmp -Foam::kineticTheoryModels::radialModels::LunSavage::g0prime -( - const volScalarField& alpha, - const dimensionedScalar& alphaMax -) const -{ - return 2.5*pow(1.0 - alpha/alphaMax, -1.0 - 2.5*alphaMax); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H deleted file mode 100644 index 81333790fd..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H +++ /dev/null @@ -1,99 +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 . - -Class - Foam::kineticTheoryModels::radialModels::LunSavage - -Description - -SourceFiles - LunSavage.C - -\*---------------------------------------------------------------------------*/ - -#ifndef LunSavage_H -#define LunSavage_H - -#include "radialModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ -namespace radialModels -{ - -/*---------------------------------------------------------------------------*\ - Class LunSavage Declaration -\*---------------------------------------------------------------------------*/ - -class LunSavage -: - public radialModel -{ - -public: - - //- Runtime type information - TypeName("LunSavage"); - - - // Constructors - - //- Construct from components - LunSavage(const dictionary& dict); - - - //- Destructor - virtual ~LunSavage(); - - - // Member Functions - - tmp g0 - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const; - - tmp g0prime - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace radialModels -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C deleted file mode 100644 index 0109f756b5..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C +++ /dev/null @@ -1,93 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "SinclairJacksonRadial.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ -namespace radialModels -{ - defineTypeNameAndDebug(SinclairJackson, 0); - - addToRunTimeSelectionTable - ( - radialModel, - SinclairJackson, - dictionary - ); -} -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModels::SinclairJackson::SinclairJackson -( - const dictionary& dict -) -: - radialModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModels::SinclairJackson::~SinclairJackson() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp -Foam::kineticTheoryModels::radialModels::SinclairJackson::g0 -( - const volScalarField& alpha, - const dimensionedScalar& alphaMax -) const -{ - return 1.0/(1.0 - pow(alpha/alphaMax, 1.0/3.0)); -} - - -Foam::tmp -Foam::kineticTheoryModels::radialModels::SinclairJackson::g0prime -( - const volScalarField& alpha, - const dimensionedScalar& alphaMax -) const -{ - return - (1.0/3.0)*pow(max(alpha, scalar(1.0e-6))/alphaMax, -2.0/3.0) - /(alphaMax*sqr(1.0 - pow(alpha/alphaMax, 1.0/3.0))); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H deleted file mode 100644 index 56931e9f01..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H +++ /dev/null @@ -1,99 +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 . - -Class - Foam::SinclairJackson - -Description - -SourceFiles - SinclairJacksonRadial.C - -\*---------------------------------------------------------------------------*/ - -#ifndef SinclairJackson_H -#define SinclairJackson_H - -#include "radialModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ -namespace radialModels -{ - -/*---------------------------------------------------------------------------*\ - Class SinclairJackson Declaration -\*---------------------------------------------------------------------------*/ - -class SinclairJackson -: - public radialModel -{ - -public: - - //- Runtime type information - TypeName("SinclairJackson"); - - - // Constructors - - //- Construct from components - SinclairJackson(const dictionary& dict); - - - //- Destructor - virtual ~SinclairJackson(); - - - // Member Functions - - tmp g0 - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const; - - tmp g0prime - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace radialModels -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.C deleted file mode 100644 index 0793fa0910..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.C +++ /dev/null @@ -1,58 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "radialModel.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - defineTypeNameAndDebug(radialModel, 0); - - defineRunTimeSelectionTable(radialModel, dictionary); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModel::radialModel -( - const dictionary& dict -) -: - dict_(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::radialModel::~radialModel() -{} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.H deleted file mode 100644 index e67a02c5c6..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/radialModel.H +++ /dev/null @@ -1,132 +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 . - -Class - Foam::kineticTheoryModels::radialModel - -SourceFiles - radialModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef radialModel_H -#define radialModel_H - -#include "dictionary.H" -#include "volFields.H" -#include "dimensionedTypes.H" -#include "runTimeSelectionTables.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - -/*---------------------------------------------------------------------------*\ - Class radialModel Declaration -\*---------------------------------------------------------------------------*/ - -class radialModel -{ - // Private member functions - - //- Disallow default bitwise copy construct - radialModel(const radialModel&); - - //- Disallow default bitwise assignment - void operator=(const radialModel&); - - -protected: - - // Protected data - - const dictionary& dict_; - - -public: - - //- Runtime type information - TypeName("radialModel"); - - // Declare runtime constructor selection table - declareRunTimeSelectionTable - ( - autoPtr, - radialModel, - dictionary, - ( - const dictionary& dict - ), - (dict) - ); - - - // Constructors - - //- Construct from components - radialModel(const dictionary& dict); - - - // Selectors - - static autoPtr New - ( - const dictionary& dict - ); - - - //- Destructor - virtual ~radialModel(); - - - // Member Functions - - //- Radial distribution function - virtual tmp g0 - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const = 0; - - //- Derivative of the radial distribution function - virtual tmp g0prime - ( - const volScalarField& alpha, - const dimensionedScalar& alphaMax - ) const = 0; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C deleted file mode 100644 index ace82f1ca2..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C +++ /dev/null @@ -1,84 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "GidaspowViscosity.H" -#include "mathematicalConstants.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - defineTypeNameAndDebug(GidaspowViscosity, 0); - addToRunTimeSelectionTable(viscosityModel, GidaspowViscosity, dictionary); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::GidaspowViscosity::GidaspowViscosity -( - const dictionary& dict -) -: - viscosityModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::GidaspowViscosity::~GidaspowViscosity() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp -Foam::kineticTheoryModels::GidaspowViscosity::mu1 -( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e -) const -{ - const scalar sqrtPi = sqrt(constant::mathematical::pi); - - return rho1*da*sqrt(Theta)* - ( - (4.0/5.0)*sqr(alpha1)*g0*(1.0 + e)/sqrtPi - + (1.0/15.0)*sqrtPi*g0*(1.0 + e)*sqr(alpha1) - + (1.0/6.0)*sqrtPi*alpha1 - + (10.0/96.0)*sqrtPi/((1.0 + e)*g0) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H deleted file mode 100644 index cb6752b900..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H +++ /dev/null @@ -1,93 +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 . - -Class - Foam::GidaspowViscosity - -Description - -SourceFiles - GidaspowViscosity.C - -\*---------------------------------------------------------------------------*/ - -#ifndef GidaspowViscosity_H -#define GidaspowViscosity_H - -#include "viscosityModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - -/*---------------------------------------------------------------------------*\ - Class GidaspowViscosity Declaration -\*---------------------------------------------------------------------------*/ - -class GidaspowViscosity -: - public viscosityModel -{ - -public: - - //- Runtime type information - TypeName("Gidaspow"); - - // Constructors - - //- Construct from components - GidaspowViscosity(const dictionary& dict); - - - //- Destructor - virtual ~GidaspowViscosity(); - - - // Member functions - - tmp mu1 - ( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C deleted file mode 100644 index b20aee6181..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C +++ /dev/null @@ -1,97 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "HrenyaSinclairViscosity.H" -#include "mathematicalConstants.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - defineTypeNameAndDebug(HrenyaSinclairViscosity, 0); - - addToRunTimeSelectionTable - ( - viscosityModel, - HrenyaSinclairViscosity, - dictionary - ); -} -} - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::HrenyaSinclairViscosity::HrenyaSinclairViscosity -( - const dictionary& dict -) -: - viscosityModel(dict), - coeffsDict_(dict.subDict(typeName + "Coeffs")), - L_(coeffsDict_.lookup("L")) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::HrenyaSinclairViscosity::~HrenyaSinclairViscosity() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp -Foam::kineticTheoryModels::HrenyaSinclairViscosity::mu1 -( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e -) const -{ - const scalar sqrtPi = sqrt(constant::mathematical::pi); - - volScalarField lamda - ( - scalar(1) + da/(6.0*sqrt(2.0)*(alpha1 + scalar(1.0e-5)))/L_ - ); - - return rho1*da*sqrt(Theta)* - ( - (4.0/5.0)*sqr(alpha1)*g0*(1.0 + e)/sqrtPi - + (1.0/15.0)*sqrtPi*g0*(1.0 + e)*(3.0*e - 1)*sqr(alpha1)/(3.0-e) - + (1.0/6.0)*sqrtPi*alpha1*(0.5*lamda + 0.25*(3.0*e - 1.0)) - /(0.5*(3.0 - e)*lamda) - + (10/96.0)*sqrtPi/((1.0 + e)*0.5*(3.0 - e)*g0*lamda) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H deleted file mode 100644 index 1b53c14b36..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H +++ /dev/null @@ -1,101 +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 . - -Class - Foam::HrenyaSinclairViscosity - -Description - -SourceFiles - HrenyaSinclairViscosity.C - -\*---------------------------------------------------------------------------*/ - -#ifndef HrenyaSinclairViscosity_H -#define HrenyaSinclairViscosity_H - -#include "viscosityModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - -/*---------------------------------------------------------------------------*\ - Class HrenyaSinclairViscosity Declaration -\*---------------------------------------------------------------------------*/ - -class HrenyaSinclairViscosity -: - public viscosityModel -{ - // Private data - - dictionary coeffsDict_; - - //- characteristic length of geometry - dimensionedScalar L_; - - -public: - - //- Runtime type information - TypeName("HrenyaSinclair"); - - - // Constructors - - //- Construct from components - HrenyaSinclairViscosity(const dictionary& dict); - - - //- Destructor - virtual ~HrenyaSinclairViscosity(); - - - // Member functions - - tmp mu1 - ( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C deleted file mode 100644 index 2d85163759..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C +++ /dev/null @@ -1,82 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "SyamlalViscosity.H" -#include "mathematicalConstants.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - defineTypeNameAndDebug(SyamlalViscosity, 0); - addToRunTimeSelectionTable(viscosityModel, SyamlalViscosity, dictionary); -} -} - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::SyamlalViscosity::SyamlalViscosity -( - const dictionary& dict -) -: - viscosityModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::SyamlalViscosity::~SyamlalViscosity() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::kineticTheoryModels::SyamlalViscosity::mu1 -( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e -) const -{ - const scalar sqrtPi = sqrt(constant::mathematical::pi); - - return rho1*da*sqrt(Theta)* - ( - (4.0/5.0)*sqr(alpha1)*g0*(1.0 + e)/sqrtPi - + (1.0/15.0)*sqrtPi*g0*(1.0 + e)*(3.0*e - 1.0)*sqr(alpha1)/(3.0 - e) - + (1.0/6.0)*alpha1*sqrtPi/(3.0 - e) - ); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H deleted file mode 100644 index 9c76cce74d..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H +++ /dev/null @@ -1,94 +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 . - -Class - Foam::SyamlalViscosity - -Description - -SourceFiles - SyamlalViscosity.C - -\*---------------------------------------------------------------------------*/ - -#ifndef SyamlalViscosity_H -#define SyamlalViscosity_H - -#include "viscosityModel.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - -/*---------------------------------------------------------------------------*\ - Class SyamlalViscosity Declaration -\*---------------------------------------------------------------------------*/ - -class SyamlalViscosity -: - public viscosityModel -{ - -public: - - //- Runtime type information - TypeName("Syamlal"); - - - // Constructors - - //- Construct from components - SyamlalViscosity(const dictionary& dict); - - - //- Destructor - virtual ~SyamlalViscosity(); - - - // Member functions - - tmp mu1 - ( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e - ) const; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.C deleted file mode 100644 index ba42c2bca3..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/none/noneViscosity.C +++ /dev/null @@ -1,75 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "noneViscosity.H" -#include "addToRunTimeSelectionTable.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - defineTypeNameAndDebug(noneViscosity, 0); - addToRunTimeSelectionTable(viscosityModel, noneViscosity, dictionary); -} -} - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::noneViscosity::noneViscosity(const dictionary& dict) -: - viscosityModel(dict) -{} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::kineticTheoryModels::noneViscosity::~noneViscosity() -{} - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - -Foam::tmp Foam::kineticTheoryModels::noneViscosity::mu1 -( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e -) const -{ - return dimensionedScalar - ( - "0", - dimensionSet(1, -1, -1, 0, 0, 0, 0), - 0.0 - )*alpha1; -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C deleted file mode 100644 index 2b50f09359..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C +++ /dev/null @@ -1,59 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "viscosityModel.H" - -// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * // - -Foam::autoPtr -Foam::kineticTheoryModels::viscosityModel::New -( - const dictionary& dict -) -{ - word viscosityModelType(dict.lookup("viscosityModel")); - - Info<< "Selecting viscosityModel " - << viscosityModelType << endl; - - dictionaryConstructorTable::iterator cstrIter = - dictionaryConstructorTablePtr_->find(viscosityModelType); - - if (cstrIter == dictionaryConstructorTablePtr_->end()) - { - FatalError - << "viscosityModel::New(const dictionary&) : " << endl - << " unknown viscosityModelType type " - << viscosityModelType - << ", constructor not in hash table" << endl << endl - << " Valid viscosityModelType types are :" << endl; - Info<< dictionaryConstructorTablePtr_->sortedToc() << abort(FatalError); - } - - return autoPtr(cstrIter()(dict)); -} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H deleted file mode 100644 index fbc2579711..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H +++ /dev/null @@ -1,130 +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 . - -Class - Foam::viscosityModel - -Description - -SourceFiles - viscosityModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef viscosityModel_H -#define viscosityModel_H - -#include "dictionary.H" -#include "volFields.H" -#include "dimensionedTypes.H" -#include "runTimeSelectionTables.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ -namespace kineticTheoryModels -{ - -/*---------------------------------------------------------------------------*\ - Class viscosityModel Declaration -\*---------------------------------------------------------------------------*/ - -class viscosityModel -{ - // Private member functions - - //- Disallow default bitwise copy construct - viscosityModel(const viscosityModel&); - - //- Disallow default bitwise assignment - void operator=(const viscosityModel&); - - -protected: - - // Protected data - - const dictionary& dict_; - - -public: - - //- Runtime type information - TypeName("viscosityModel"); - - // Declare runtime constructor selection table - declareRunTimeSelectionTable - ( - autoPtr, - viscosityModel, - dictionary, - ( - const dictionary& dict - ), - (dict) - ); - - - // Constructors - - //- Construct from components - viscosityModel(const dictionary& dict); - - - // Selectors - - static autoPtr New - ( - const dictionary& dict - ); - - - //- Destructor - virtual ~viscosityModel(); - - - // Member Functions - - virtual tmp mu1 - ( - const volScalarField& alpha1, - const volScalarField& Theta, - const volScalarField& g0, - const dimensionedScalar& rho1, - const dimensionedScalar& da, - const dimensionedScalar& e - ) const = 0; -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace kineticTheoryModels -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/liftDragCoeffs.H b/applications/solvers/multiphase/twoPhaseEulerFoam/liftDragCoeffs.H deleted file mode 100644 index 415afe9483..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/liftDragCoeffs.H +++ /dev/null @@ -1,31 +0,0 @@ - volVectorField Ur(U1 - U2); - volScalarField magUr(mag(Ur) + residualSlip); - - volScalarField Ka(drag1->K(magUr)); - volScalarField K(Ka); - - if (dragPhase == "2") - { - volScalarField Kb(drag2->K(magUr)); - K = Kb; - } - else if (dragPhase == "blended") - { - volScalarField Kb(drag2->K(magUr)); - K = (alpha2*Ka + alpha1*Kb); - } - - volVectorField liftCoeff - ( - Cl*(alpha2*rho2 + alpha1*rho1)*(Ur ^ fvc::curl(U)) - ); - - // Remove lift and drag at fixed-flux boundaries - forAll(phi1.boundaryField(), patchi) - { - if (isA(phi1.boundaryField()[patchi])) - { - K.boundaryField()[patchi] = 0.0; - liftCoeff.boundaryField()[patchi] = vector::zero; - } - } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/newVirtualMass/DDtU.H b/applications/solvers/multiphase/twoPhaseEulerFoam/newVirtualMass/DDtU.H deleted file mode 100644 index 9ce4537979..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/newVirtualMass/DDtU.H +++ /dev/null @@ -1,11 +0,0 @@ -{ - DDtU1 = - fvc::ddt(U1) - + fvc::div(phi, U1) - - fvc::div(phi)*U1; - - DDtU2 = - fvc::ddt(U2) - + fvc::div(phi, U2) - - fvc::div(phi)*U2; -} diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/newVirtualMass/UEqns.H b/applications/solvers/multiphase/twoPhaseEulerFoam/newVirtualMass/UEqns.H deleted file mode 100644 index cae326e44a..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/newVirtualMass/UEqns.H +++ /dev/null @@ -1,120 +0,0 @@ -fvVectorMatrix U1Eqn(U1, U1.dimensions()*dimVol/dimTime); -fvVectorMatrix U2Eqn(U2, U2.dimensions()*dimVol/dimTime); - -{ - volScalarField Cvma - ( - Cvm - /( - 1 - + mag(fvc::grad(alpha1)) - *dimensionedScalar("l", dimLength, 1e-2) - ) - ); - - { - volTensorField gradU1T(T(fvc::grad(U1))); - - if (kineticTheory.on()) - { - kineticTheory.solve(gradU1T); - nuEff1 = kineticTheory.mu1()/rho1; - } - else // If not using kinetic theory is using Ct model - { - nuEff1 = sqr(Ct)*nut2 + nu1; - } - - volTensorField Rc1 - ( - "Rc1", - (((2.0/3.0)*I)*nuEff1)*tr(gradU1T) - nuEff1*gradU1T - ); - - if (kineticTheory.on()) - { - Rc1 -= ((kineticTheory.lambda()/rho1)*tr(gradU1T))*tensor(I); - } - - surfaceScalarField phiR1 - ( - -fvc::interpolate(nuEff1)*mesh.magSf()*fvc::snGrad(alpha1) - /fvc::interpolate(alpha1 + scalar(0.001)) - ); - - U1Eqn = - ( - fvm::ddt(U1) - + fvm::div(phi1, U1) - - fvm::Sp(fvc::div(phi1), U1) - - + Cvma*alpha2*rho/rho1* - ( - fvm::ddt(U1) - + fvm::div(phi, U1) - - fvm::Sp(fvc::div(phi), U1) - ) - - - fvm::laplacian(nuEff1, U1) - + fvc::div(Rc1) - - + fvm::div(phiR1, U1, "div(phi1,U1)") - - fvm::Sp(fvc::div(phiR1), U1) - + (fvc::grad(alpha1)/(fvc::average(alpha1) + scalar(0.001)) & Rc1) - == - // g // Buoyancy term transfered to p-equation - - fvm::Sp(alpha2/rho1*K, U1) - //+ alpha2/rho1*K*U2 // Explicit drag transfered to p-equation - // - fvm::Sp(K/rho1, U1) - ////+ K/rho1*U // Explicit drag transfered to p-equation - - alpha2/rho1*liftCoeff + Cvma*alpha2*rho*DDtU2/rho1 - ); - - U1Eqn.relax(); - } - - { - volTensorField gradU2T(T(fvc::grad(U2))); - volTensorField Rc2 - ( - "Rc2", - (((2.0/3.0)*I)*nuEff2)*tr(gradU2T) - nuEff2*gradU2T - ); - - surfaceScalarField phiR2 - ( - -fvc::interpolate(nuEff2)*mesh.magSf()*fvc::snGrad(alpha2) - /fvc::interpolate(alpha2 + scalar(0.001)) - ); - - U2Eqn = - ( - fvm::ddt(U2) - + fvm::div(phi2, U2) - - fvm::Sp(fvc::div(phi2), U2) - - + Cvma*alpha1*rho/rho2* - ( - fvm::ddt(U2) - + fvm::div(phi, U2) - - fvm::Sp(fvc::div(phi), U2) - ) - - - fvm::laplacian(nuEff2, U2) - + fvc::div(Rc2) - - + fvm::div(phiR2, U2, "div(phi2,U2)") - - fvm::Sp(fvc::div(phiR2), U2) - + (fvc::grad(alpha2)/(fvc::average(alpha2) + scalar(0.001)) & Rc2) - == - // g // Buoyancy term transfered to p-equation - - fvm::Sp(alpha1/rho2*K, U2) - //+ alpha1/rho2*K*U1 // Explicit drag transfered to p-equation - // - fvm::Sp(K/rho2, U2) - ////+ K/rho2*U // Explicit drag transfered to p-equation - + alpha1/rho2*liftCoeff + Cvma*alpha1*rho*DDtU1/rho2 - ); - - U2Eqn.relax(); - } -} diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H b/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H index 546e1a3e41..e9211def7f 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/pEqn.H @@ -2,16 +2,24 @@ surfaceScalarField alpha1f(fvc::interpolate(alpha1)); surfaceScalarField alpha2f(scalar(1) - alpha1f); - volScalarField rAU1(1.0/U1Eqn.A()); - volScalarField rAU2(1.0/U2Eqn.A()); + rAU1 = 1.0/U1Eqn.A(); + rAU2 = 1.0/U2Eqn.A(); - rAU1f = 1.0/fvc::interpolate(U1Eqn.A()); - surfaceScalarField rAU2f(1.0/fvc::interpolate(U2Eqn.A())); + surfaceScalarField rAlphaAU1f(fvc::interpolate(alpha1*rAU1)); + surfaceScalarField rAlphaAU2f(fvc::interpolate(alpha2*rAU2)); - volVectorField HbyA1("HbyA1", U1); + volVectorField HbyA1 + ( + IOobject::groupName("HbyA", phase1.name()), + U1 + ); HbyA1 = rAU1*U1Eqn.H(); - volVectorField HbyA2("HbyA2", U2); + volVectorField HbyA2 + ( + IOobject::groupName("HbyA", phase2.name()), + U2 + ); HbyA2 = rAU2*U2Eqn.H(); mrfZones.absoluteFlux(phi1.oldTime()); @@ -19,30 +27,34 @@ mrfZones.absoluteFlux(phi2.oldTime()); mrfZones.absoluteFlux(phi2); - surfaceScalarField ppDrag("ppDrag", 0.0*phi1); + // Phase-1 pressure flux (e.g. due to particle-particle pressure) + surfaceScalarField phiP1 + ( + "phiP1", + fvc::interpolate((1.0/rho1)*rAU1*turbulence1().pPrime()) + *fvc::snGrad(alpha1)*mesh.magSf() + ); - if (g0.value() > 0.0) - { - ppDrag -= ppMagf*fvc::snGrad(alpha1)*mesh.magSf(); - } - - if (kineticTheory.on()) - { - ppDrag -= rAU1f*fvc::snGrad(kineticTheory.pa()/rho1)*mesh.magSf(); - } + // Phase-2 pressure flux (e.g. due to particle-particle pressure) + surfaceScalarField phiP2 + ( + "phiP2", + fvc::interpolate((1.0/rho2)*rAU2*turbulence2().pPrime()) + *fvc::snGrad(alpha2)*mesh.magSf() + ); surfaceScalarField phiHbyA1 ( - "phiHbyA1", + IOobject::groupName("phiHbyA", phase1.name()), (fvc::interpolate(HbyA1) & mesh.Sf()) - + fvc::ddtPhiCorr(rAU1, U1, phi1) + + fvc::ddtPhiCorr(rAU1, alpha1, U1, phi1) ); surfaceScalarField phiHbyA2 ( - "phiHbyA2", + IOobject::groupName("phiHbyA", phase2.name()), (fvc::interpolate(HbyA2) & mesh.Sf()) - + fvc::ddtPhiCorr(rAU2, U2, phi2) + + fvc::ddtPhiCorr(rAU2, alpha2, U2, phi2) ); phi = alpha1f*phiHbyA1 + alpha2f*phiHbyA2; @@ -50,16 +62,17 @@ phiHbyA1 += ( - fvc::interpolate(alpha2/rho1*K*rAU1)*phi2 - + ppDrag - + rAU1f*(g & mesh.Sf()) + fvc::interpolate((1.0/rho1)*rAU1*dragCoeff)*phi2 + - phiP1 + + rAlphaAU1f*(g & mesh.Sf()) ); mrfZones.relativeFlux(phiHbyA1); phiHbyA2 += ( - fvc::interpolate(alpha1/rho2*K*rAU2)*phi1 - + rAU2f*(g & mesh.Sf()) + fvc::interpolate((1.0/rho2)*rAU2*dragCoeff)*phi1 + - phiP2 + + rAlphaAU2f*(g & mesh.Sf()) ); mrfZones.relativeFlux(phiHbyA2); @@ -70,55 +83,145 @@ surfaceScalarField phiHbyA("phiHbyA", alpha1f*phiHbyA1 + alpha2f*phiHbyA2); - HbyA1 += alpha2*(1.0/rho1)*rAU1*K*U2; - HbyA2 += alpha1*(1.0/rho2)*rAU2*K*U1; + HbyA1 += (1.0/rho1)*rAU1*dragCoeff*U2; + HbyA2 += (1.0/rho2)*rAU2*dragCoeff*U1; surfaceScalarField Dp ( "Dp", - alpha1f*rAU1f/rho1 + alpha2f*rAU2f/rho2 + mag + ( + alpha1f*rAlphaAU1f/fvc::interpolate(rho1) + + alpha2f*rAlphaAU2f/fvc::interpolate(rho2) + ) ); + tmp pEqnComp1; + tmp pEqnComp2; + + if (pimple.transonic()) + { + surfaceScalarField phid1 + ( + IOobject::groupName("phid", phase1.name()), + fvc::interpolate(psi1)*phi1 + ); + surfaceScalarField phid2 + ( + IOobject::groupName("phid", phase2.name()), + fvc::interpolate(psi2)*phi2 + ); + + pEqnComp1 = + fvc::ddt(rho1) + + fvc::div(phi1, rho1) - fvc::Sp(fvc::div(phi1), rho1) + + correction + ( + psi1*fvm::ddt(p) + + fvm::div(phid1, p) - fvm::Sp(fvc::div(phid1), p) + ); + deleteDemandDrivenData(pEqnComp1().faceFluxCorrectionPtr()); + pEqnComp1().relax(); + + pEqnComp2 = + fvc::ddt(rho2) + + fvc::div(phi2, rho2) - fvc::Sp(fvc::div(phi2), rho2) + + correction + ( + psi2*fvm::ddt(p) + + fvm::div(phid2, p) - fvm::Sp(fvc::div(phid2), p) + ); + deleteDemandDrivenData(pEqnComp2().faceFluxCorrectionPtr()); + pEqnComp2().relax(); + } + else + { + pEqnComp1 = + fvc::ddt(rho1) + psi1*correction(fvm::ddt(p)) + + fvc::div(phi1, rho1) - fvc::Sp(fvc::div(phi1), rho1); + + pEqnComp2 = + fvc::ddt(rho2) + psi2*correction(fvm::ddt(p)) + + fvc::div(phi2, rho2) - fvc::Sp(fvc::div(phi2), rho2); + } + + // Cache p prior to solve for density update + volScalarField p_0(p); + while (pimple.correctNonOrthogonal()) { - fvScalarMatrix pEqn + fvScalarMatrix pEqnIncomp ( - fvm::laplacian(Dp, p) == fvc::div(phiHbyA) + fvc::div(phiHbyA) + - fvm::laplacian(Dp, p) ); - pEqn.setReference(pRefCell, pRefValue); - - pEqn.solve(mesh.solver(p.select(pimple.finalInnerIter()))); + solve + ( + ( + (alpha1/rho1)*pEqnComp1() + + (alpha2/rho2)*pEqnComp2() + ) + + pEqnIncomp, + mesh.solver(p.select(pimple.finalInnerIter())) + ); if (pimple.finalNonOrthogonalIter()) { - surfaceScalarField SfGradp(pEqn.flux()/Dp); + surfaceScalarField mSfGradp(pEqnIncomp.flux()/Dp); - phi1 = phiHbyA1 - rAU1f*SfGradp/rho1; - phi2 = phiHbyA2 - rAU2f*SfGradp/rho2; + phi1 = phiHbyA1 + rAlphaAU1f*mSfGradp/fvc::interpolate(rho1); + phi2 = phiHbyA2 + rAlphaAU2f*mSfGradp/fvc::interpolate(rho2); phi = alpha1f*phi1 + alpha2f*phi2; + dgdt = + ( + pos(alpha2)*(pEqnComp2 & p)/rho2 + - pos(alpha1)*(pEqnComp1 & p)/rho1 + ); + p.relax(); - SfGradp = pEqn.flux()/Dp; + mSfGradp = pEqnIncomp.flux()/Dp; U1 = HbyA1 - + fvc::reconstruct - ( - ppDrag - + rAU1f*((g & mesh.Sf()) - SfGradp/rho1) - ); + + fvc::reconstruct + ( + rAlphaAU1f + *( + (g & mesh.Sf()) + + mSfGradp/fvc::interpolate(rho1) + ) + - phiP1 + ); U1.correctBoundaryConditions(); U2 = HbyA2 - + fvc::reconstruct - ( - rAU2f*((g & mesh.Sf()) - SfGradp/rho2) - ); + + fvc::reconstruct + ( + rAlphaAU2f + *( + (g & mesh.Sf()) + + mSfGradp/fvc::interpolate(rho2) + ) + - phiP2 + ); U2.correctBoundaryConditions(); - U = alpha1*U1 + alpha2*U2; + U = fluid.U(); } } -} -#include "continuityErrs.H" + p = max(p, pMin); + + // Update densities from change in p + rho1 += psi1*(p - p_0); + rho2 += psi2*(p - p_0); + + K1 = 0.5*magSqr(U1); + K2 = 0.5*magSqr(U2); + + if (thermo1.dpdt() || thermo2.dpdt()) + { + dpdt = fvc::ddt(p); + } +} diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/packingLimiter.H b/applications/solvers/multiphase/twoPhaseEulerFoam/packingLimiter.H deleted file mode 100644 index 249f1035a1..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/packingLimiter.H +++ /dev/null @@ -1,36 +0,0 @@ - if (packingLimiter) - { - // Calculating exceeding volume fractions - volScalarField alpha1Ex(max(alpha1 - alphaMax, scalar(0))); - - // Finding neighbouring cells of the whole domain - labelListList neighbour = mesh.cellCells(); - scalarField cellVolumes(mesh.cellVolumes()); - - forAll (alpha1Ex, celli) - { - // Finding the labels of the neighbouring cells - labelList neighbourCell = neighbour[celli]; - - // Initializing neighbouring cells contribution - scalar neighboursEx = 0.0; - - forAll (neighbourCell, cellj) - { - labelList neighboursNeighbour = neighbour[neighbourCell[cellj]]; - scalar neighboursNeighbourCellVolumes = 0.0; - - forAll (neighboursNeighbour, cellk) - { - neighboursNeighbourCellVolumes += - cellVolumes[neighboursNeighbour[cellk]]; - } - - neighboursEx += - alpha1Ex[neighbourCell[cellj]]*cellVolumes[celli] - /neighboursNeighbourCellVolumes; - } - - alpha1[celli] += neighboursEx - alpha1Ex[celli]; - } - } diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/files b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/files similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/files rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/files diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/options b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/options similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/options rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/Make/options diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Gidaspow/GidaspowConductivity.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/HrenyaSinclair/HrenyaSinclairConductivity.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/Syamlal/SyamlalConductivity.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C index 145f10e218..1430854afb 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/conductivityModel.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C index 21aa88ec66..7f4b9f6359 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/conductivityModel/conductivityModel/newConductivityModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJackson/JohnsonJacksonFrictionalStress.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/frictionalStressModel.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C index 4067c154fb..ed9ae62d33 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/frictionalStressModel/newFrictionalStressModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/Lun/LunPressure.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/SyamlalRogersOBrien/SyamlalRogersOBrienPressure.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C index 6bbae86d37..b883472969 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/granularPressureModel.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C index d8e1540f0f..6320012884 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/granularPressureModel/granularPressureModel/newGranularPressureModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/CarnahanStarling/CarnahanStarlingRadial.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/LunSavage/LunSavageRadial.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/SinclairJackson/SinclairJacksonRadial.H diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/newRadialModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/newRadialModel.C similarity index 97% rename from applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/newRadialModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/newRadialModel.C index f5043486a3..3ea1770794 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/kineticTheoryModels/radialModel/radialModel/newRadialModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/newRadialModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/radialModel/radialModel/radialModel.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Gidaspow/GidaspowViscosity.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/HrenyaSinclair/HrenyaSinclairViscosity.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/Syamlal/SyamlalViscosity.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/none/noneViscosity.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C index 2b50f09359..58da2a786c 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/newViscosityModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C index dc4c1ca1de..c3c414dd28 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/kineticTheoryModels/viscosityModel/viscosityModel/viscosityModel.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phaseIncompressibleTurbulenceModels.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phaseIncompressibleTurbulenceModels.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phaseIncompressibleTurbulenceModels.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phaseIncompressibleTurbulenceModels.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/phaseIncompressibleTurbulenceModels/phasePressureModel/phasePressureModel.H diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/Make/files b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/Make/files deleted file mode 100644 index 719f858c3e..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -phaseModel/phaseModel.C - -LIB = $(FOAM_LIBBIN)/libphaseModel diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/Make/options b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/Make/options deleted file mode 100644 index 0ec1139209..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/Make/options +++ /dev/null @@ -1,6 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/transportModels/incompressible/lnInclude - -LIB_LIBS = \ - -lincompressibleTransportModels diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/phaseModel/phaseModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/phaseModel/phaseModel.C deleted file mode 100644 index 85ee12b316..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/phaseModel/phaseModel.C +++ /dev/null @@ -1,168 +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 . - -\*---------------------------------------------------------------------------*/ - -#include "phaseModel.H" -#include "fixedValueFvPatchFields.H" -#include "slipFvPatchFields.H" -#include "surfaceInterpolate.H" - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Foam::phaseModel::phaseModel -( - const fvMesh& mesh, - const dictionary& transportProperties, - const word& phaseName -) -: - dict_ - ( - transportProperties.subDict("phase" + phaseName) - ), - name_(phaseName), - d_ - ( - "d", - dimLength, - dict_.lookup("d") - ), - nu_ - ( - "nu", - dimensionSet(0, 2, -1, 0, 0), - dict_.lookup("nu") - ), - rho_ - ( - "rho", - dimDensity, - dict_.lookup("rho") - ), - U_ - ( - IOobject - ( - "U" + phaseName, - mesh.time().timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ) -{ - const word phiName = "phi" + phaseName; - - IOobject phiHeader - ( - phiName, - mesh.time().timeName(), - mesh, - IOobject::NO_READ - ); - - if (phiHeader.headerOk()) - { - Info<< "Reading face flux field " << phiName << endl; - - phiPtr_.reset - ( - new surfaceScalarField - ( - IOobject - ( - phiName, - mesh.time().timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh - ) - ); - } - else - { - Info<< "Calculating face flux field " << phiName << endl; - - wordList phiTypes - ( - U_.boundaryField().size(), - calculatedFvPatchScalarField::typeName - ); - - forAll(U_.boundaryField(), i) - { - if - ( - isA(U_.boundaryField()[i]) - || isA(U_.boundaryField()[i]) - ) - { - phiTypes[i] = fixedValueFvPatchScalarField::typeName; - } - } - - phiPtr_.reset - ( - new surfaceScalarField - ( - IOobject - ( - phiName, - mesh.time().timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - fvc::interpolate(U_) & mesh.Sf(), - phiTypes - ) - ); - } -} - - -Foam::autoPtr Foam::phaseModel::New -( - const fvMesh& mesh, - const dictionary& transportProperties, - const word& phaseName -) -{ - return autoPtr - ( - new phaseModel(mesh, transportProperties, phaseName) - ); -} - - -// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // - -Foam::phaseModel::~phaseModel() -{} - - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/phaseModel/phaseModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/phaseModel/phaseModel.H deleted file mode 100644 index edf4ce7431..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseModel/phaseModel/phaseModel.H +++ /dev/null @@ -1,153 +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 . - -Class - Foam::phaseModel - -SourceFiles - phaseModel.C - -\*---------------------------------------------------------------------------*/ - -#ifndef phaseModel_H -#define phaseModel_H - -#include "dictionary.H" -#include "dimensionedScalar.H" -#include "volFields.H" -#include "surfaceFields.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -namespace Foam -{ - -/*---------------------------------------------------------------------------*\ - Class phaseModel Declaration -\*---------------------------------------------------------------------------*/ - -class phaseModel -{ - // Private data - - dictionary dict_; - - //- Name of phase - word name_; - - //- Characteristic diameter of phase - dimensionedScalar d_; - - //- kinematic viscosity - dimensionedScalar nu_; - - //- density - dimensionedScalar rho_; - - //- Velocity - volVectorField U_; - - //- Fluxes - autoPtr phiPtr_; - - -public: - - // Constructors - - phaseModel - ( - const fvMesh& mesh, - const dictionary& transportProperties, - const word& phaseName - ); - - - // Selectors - - //- Return a reference to the selected turbulence model - static autoPtr New - ( - const fvMesh& mesh, - const dictionary& transportProperties, - const word& phaseName - ); - - - //- Destructor - virtual ~phaseModel(); - - - // Member Functions - - const word& name() const - { - return name_; - } - - const dimensionedScalar& d() const - { - return d_; - } - - const dimensionedScalar& nu() const - { - return nu_; - } - - const dimensionedScalar& rho() const - { - return rho_; - } - - const volVectorField& U() const - { - return U_; - } - - volVectorField& U() - { - return U_; - } - - const surfaceScalarField& phi() const - { - return phiPtr_(); - } - - surfaceScalarField& phi() - { - return phiPtr_(); - } -}; - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -} // End namespace Foam - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -#endif - -// ************************************************************************* // diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/readPPProperties.H b/applications/solvers/multiphase/twoPhaseEulerFoam/readPPProperties.H index a655736c54..4f32564a48 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/readPPProperties.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/readPPProperties.H @@ -5,17 +5,27 @@ "ppProperties", runTime.constant(), mesh, - IOobject::MUST_READ_IF_MODIFIED, + IOobject::MUST_READ, IOobject::NO_WRITE ) ); - scalar preAlphaExp(readScalar(ppProperties.lookup("preAlphaExp"))); + scalar preAlphaExp + ( + readScalar(ppProperties.lookup("preAlphaExp")) + ); - scalar alphaMax(readScalar(ppProperties.lookup("alphaMax"))); + scalar alphaMax + ( + readScalar(ppProperties.lookup("alphaMax")) + ); - scalar expMax(readScalar(ppProperties.lookup("expMax"))); + scalar expMax + ( + readScalar(ppProperties.lookup("expMax")) + ); - dimensionedScalar g0(ppProperties.lookup("g0")); - - Switch packingLimiter(ppProperties.lookup("packingLimiter")); + dimensionedScalar g0 + ( + ppProperties.lookup("g0") + ); diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/readTwoPhaseEulerFoamControls.H b/applications/solvers/multiphase/twoPhaseEulerFoam/readTwoPhaseEulerFoamControls.H index 813fdd8f10..29353a8fa1 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/readTwoPhaseEulerFoamControls.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/readTwoPhaseEulerFoamControls.H @@ -1,4 +1,7 @@ #include "readTimeControls.H" #include "alphaControls.H" - Switch correctAlpha(pimple.dict().lookup("correctAlpha")); + Switch implicitPhasePressure + ( + alphaControls.lookupOrDefault("implicitPhasePressure", false) + ); diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseEulerFoam.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseEulerFoam.C index 67e4174a3b..7b8509337d 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseEulerFoam.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseEulerFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -25,26 +25,19 @@ Application twoPhaseEulerFoam Description - Solver for a system of 2 incompressible fluid phases with one phase - dispersed, e.g. gas bubbles in a liquid or solid particles in a gas. + Solver for a system of 2 compressible fluid phases with one phase + dispersed, e.g. gas bubbles in a liquid including heat-transfer. \*---------------------------------------------------------------------------*/ #include "fvCFD.H" #include "MULES.H" #include "subCycle.H" -#include "nearWallDist.H" -#include "wallFvPatch.H" -#include "fixedValueFvsPatchFields.H" -#include "Switch.H" - -#include "IFstream.H" -#include "OFstream.H" - +#include "rhoThermo.H" +#include "twoPhaseSystem.H" #include "dragModel.H" -#include "phaseModel.H" -#include "kineticTheoryModel.H" - +#include "heatTransferModel.H" +#include "PhaseIncompressibleTurbulenceModel.H" #include "pimpleControl.H" #include "IOMRFZoneList.H" @@ -58,11 +51,10 @@ int main(int argc, char *argv[]) #include "createMesh.H" #include "readGravitationalAcceleration.H" #include "createFields.H" - #include "readPPProperties.H" - #include "initContinuityErrs.H" #include "createMRFZones.H" + #include "initContinuityErrs.H" #include "readTimeControls.H" - #include "CourantNo.H" + #include "CourantNos.H" #include "setInitialDeltaT.H" pimpleControl pimple(mesh); @@ -84,33 +76,29 @@ int main(int argc, char *argv[]) while (pimple.loop()) { #include "alphaEqn.H" - #include "liftDragCoeffs.H" + #include "EEqns.H" #include "UEqns.H" // --- Pressure corrector loop while (pimple.correct()) { #include "pEqn.H" - - if (correctAlpha && !pimple.finalIter()) - { - #include "alphaEqn.H" - } } #include "DDtU.H" if (pimple.turbCorr()) { - #include "kEpsilon.H" + turbulence1->correct(); + turbulence2->correct(); } } #include "write.H" - Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" - << " ClockTime = " << runTime.elapsedClockTime() << " s" - << nl << endl; + Info<< "ExecutionTime = " + << runTime.elapsedCpuTime() + << " s\n\n" << endl; } Info<< "End\n" << endl; diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/Make/files b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/Make/files similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/Make/files rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/Make/files diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/Make/options b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/Make/options similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/Make/options rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/Make/options diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.C index 7be2be6d56..315f160893 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.H b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.H similarity index 97% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.H index 5ce8c9a3d9..071820c319 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/constantDiameter/constantDiameter.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.C similarity index 95% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.C index 800c700dce..2618815d24 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.H similarity index 97% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.H index ad4a41e2ed..c14f65e364 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/diameterModel.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/newDiameterModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/newDiameterModel.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/newDiameterModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/newDiameterModel.C index 01d685ad56..b9014f3f46 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/newDiameterModel.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/diameterModel/newDiameterModel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.C similarity index 96% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.C index 39d6f1afbd..4b9e571503 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.H b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.H similarity index 97% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.H index 29fe2c8642..0d155ad16e 100644 --- a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.H +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/isothermalDiameter/isothermalDiameter.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.H b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/phaseModel/phaseModel.H diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C diff --git a/applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.H b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.H similarity index 100% rename from applications/solvers/multiphase/compressibleTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.H rename to applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.H diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/wallFunctions.H b/applications/solvers/multiphase/twoPhaseEulerFoam/wallFunctions.H deleted file mode 100644 index c91cce9a00..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/wallFunctions.H +++ /dev/null @@ -1,81 +0,0 @@ -{ - labelList cellBoundaryFaceCount(epsilon.size(), 0); - - scalar Cmu25 = ::pow(Cmu.value(), 0.25); - scalar Cmu75 = ::pow(Cmu.value(), 0.75); - scalar kappa_ = kappa.value(); - scalar nu2_ = nu2.value(); - - const fvPatchList& patches = mesh.boundary(); - - //- Initialise the near-wall P field to zero - forAll(patches, patchi) - { - const fvPatch& currPatch = patches[patchi]; - - if (isA(currPatch)) - { - forAll(currPatch, facei) - { - label faceCelli = currPatch.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& currPatch = patches[patchi]; - - if (isA(currPatch)) - { - const scalarField& nut2w = nut2.boundaryField()[patchi]; - - scalarField magFaceGradU(mag(U2.boundaryField()[patchi].snGrad())); - - forAll(currPatch, facei) - { - label faceCelli = currPatch.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] += - (nut2w[facei] + nu2_)*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/twoPhaseEulerFoam/wallViscosity.H b/applications/solvers/multiphase/twoPhaseEulerFoam/wallViscosity.H deleted file mode 100644 index bd51ed7dd1..0000000000 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/wallViscosity.H +++ /dev/null @@ -1,36 +0,0 @@ -{ - scalar Cmu25 = ::pow(Cmu.value(), 0.25); - scalar kappa_ = kappa.value(); - scalar E_ = E.value(); - scalar nu2_ = nu2.value(); - - const fvPatchList& patches = mesh.boundary(); - - forAll(patches, patchi) - { - const fvPatch& currPatch = patches[patchi]; - - if (isA(currPatch)) - { - scalarField& nutw = nut2.boundaryField()[patchi]; - - forAll(currPatch, facei) - { - label faceCelli = currPatch.faceCells()[facei]; - - // calculate yPlus - scalar yPlus = - Cmu25*y[patchi][facei]*::sqrt(k[faceCelli])/nu2_; - - if (yPlus > 11.6) - { - nutw[facei] = nu2_*(yPlus*kappa_/::log(E_*yPlus) -1); - } - else - { - nutw[facei] = 0.0; - } - } - } - } -} diff --git a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.C b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.C index 7eb8216b00..3afdf9cf13 100644 --- a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.C +++ b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.C @@ -31,12 +31,6 @@ License #include "labelIOField.H" #include "pointConversion.H" -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * Static Member Functions * * * * * * * * * * * * * // - - // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // template @@ -61,6 +55,8 @@ Foam::DelaunayMesh::DelaunayMesh cellCount_(0), runTime_(runTime) { + Info<< "Reading " << meshName << " from " << runTime.timeName() << endl; + pointIOField pts ( IOobject @@ -74,83 +70,71 @@ Foam::DelaunayMesh::DelaunayMesh ) ); - labelIOField types - ( - IOobject - ( - "types", - runTime.timeName(), - meshName, - runTime, - IOobject::READ_IF_PRESENT, - IOobject::NO_WRITE - ) - ); - - labelIOField indices - ( - IOobject - ( - "indices", - runTime.timeName(), - meshName, - runTime, - IOobject::READ_IF_PRESENT, - IOobject::NO_WRITE - ) - ); - - labelIOField processorIndices - ( - IOobject - ( - "processorIndices", - runTime.timeName(), - meshName, - runTime, - IOobject::READ_IF_PRESENT, - IOobject::NO_WRITE - ) - ); - if (pts.headerOk()) { - forAll(pts, ptI) + labelIOField types + ( + IOobject + ( + "types", + runTime.timeName(), + meshName, + runTime, + IOobject::MUST_READ, + IOobject::NO_WRITE + ) + ); + +// Do not read in indices +// labelIOField indices +// ( +// IOobject +// ( +// "indices", +// runTime.timeName(), +// meshName, +// runTime, +// IOobject::MUST_READ, +// IOobject::NO_WRITE +// ) +// ); + + labelIOField processorIndices + ( + IOobject + ( + "processorIndices", + runTime.timeName(), + meshName, + runTime, + IOobject::MUST_READ, + IOobject::NO_WRITE + ) + ); + + List pointsToInsert(pts.size()); + + forAll(pointsToInsert, pI) { - Vertex_handle vh = this->insert(toPoint(pts[ptI])); - - if (indices.headerOk()) - { - vh->index() = indices[ptI]; - vertexCount_++; - } - else - { - vh->index() = getNewVertexIndex(); - } - - if (processorIndices.headerOk()) - { - vh->procIndex() = processorIndices[ptI]; - } - else - { - vh->procIndex() = Pstream::myProcNo(); - } - - if (types.headerOk()) - { - vh->type() = - static_cast - ( - types[ptI] - ); - } - else - { - vh->type() = Vb::vtUnassigned; - } + pointsToInsert[pI] = + Vb + ( + toPoint(pts[pI]), + pI, + static_cast(types[pI]), + processorIndices[pI] + ); } + + rangeInsertWithInfo + ( + pointsToInsert.begin(), + pointsToInsert.end(), + false, + false + ); + + vertexCount_ = Triangulation::number_of_vertices(); } } @@ -219,7 +203,7 @@ void Foam::DelaunayMesh::insertPoints(const List& vertices) ( vertices.begin(), vertices.end(), - true + false ); } @@ -288,7 +272,8 @@ void Foam::DelaunayMesh::rangeInsertWithInfo ( PointIterator begin, PointIterator end, - bool printErrors + bool printErrors, + bool reIndex ) { typedef DynamicList @@ -348,7 +333,14 @@ void Foam::DelaunayMesh::rangeInsertWithInfo } else { - hint->index() = getNewVertexIndex(); + if (reIndex) + { + hint->index() = getNewVertexIndex(); + } + else + { + hint->index() = vert.index(); + } hint->type() = vert.type(); hint->procIndex() = vert.procIndex(); hint->targetCellSize() = vert.targetCellSize(); @@ -358,15 +350,6 @@ void Foam::DelaunayMesh::rangeInsertWithInfo } -// * * * * * * * * * * * * * * Member Operators * * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * Friend Functions * * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * Friend Operators * * * * * * * * * * * * * * // - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // #include "DelaunayMeshIO.C" diff --git a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.H b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.H index 63d227fcca..a7cbf26766 100644 --- a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.H +++ b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMesh.H @@ -90,6 +90,7 @@ public: FixedList::Hash<> > labelTolabelPairHashTable; + private: // Private data @@ -184,62 +185,84 @@ public: // Member Functions - inline const Time& time() const; + // Access - inline void timeCheck - ( - const string& description, - const bool check = true - ) const; - - inline label getNewVertexIndex() const; - - inline label getNewCellIndex() const; - - inline label cellCount() const; - - inline void resetCellCount(); - - inline label vertexCount() const; - - inline void resetVertexCount(); + //- Return a reference to the Time object + inline const Time& time() const; - //- Remove the entire triangulation - void reset(); + // Check - void insertPoints(const List& vertices); - - //- Function inserting points into a triangulation and setting the - // index and type data of the point in the correct order. This is - // faster than inserting points individually. - // - // Adapted from a post on the CGAL lists: 2010-01/msg00004.html by - // Sebastien Loriot (Geometry Factory). - template - void rangeInsertWithInfo - ( - PointIterator begin, - PointIterator end, - bool printErrors = true - ); + //- Write the cpuTime to screen + inline void timeCheck + ( + const string& description, + const bool check = true + ) const; - // Queries + // Indexing functions - void printInfo(Ostream& os) const; + //- Create a new unique cell index and return + inline label getNewCellIndex() const; - void printVertexInfo(Ostream& os) const; + //- Create a new unique vertex index and return + inline label getNewVertexIndex() const; - //- Create an fvMesh from the triangulation. - // The mesh is not parallel consistent - only used for viewing - autoPtr createMesh - ( - const fileName& name, - labelTolabelPairHashTable& vertexMap, - labelList& cellMap, - const bool writeDelaunayData = true - ) const; + //- Return the cell count (the next unique cell index) + inline label cellCount() const; + + //- Return the vertex count (the next unique vertex index) + inline label vertexCount() const; + + //- Set the cell count to zero + inline void resetCellCount(); + + //- Set the vertex count to zero + inline void resetVertexCount(); + + + // Triangulation manipulation functions + + //- Clear the entire triangulation + void reset(); + + //- Insert the list of vertices (calls rangeInsertWithInfo) + void insertPoints(const List& vertices); + + //- Function inserting points into a triangulation and setting the + // index and type data of the point in the correct order. This is + // faster than inserting points individually. + // + // Adapted from a post on the CGAL lists: 2010-01/msg00004.html by + // Sebastien Loriot (Geometry Factory). + template + void rangeInsertWithInfo + ( + PointIterator begin, + PointIterator end, + bool printErrors = false, + bool reIndex = true + ); + + + // Write + + //- Write mesh statistics to stream + void printInfo(Ostream& os) const; + + //- Write vertex statistics in the form of a table to stream + void printVertexInfo(Ostream& os) const; + + //- Create an fvMesh from the triangulation. + // The mesh is not parallel consistent - only used for viewing + autoPtr createMesh + ( + const fileName& name, + labelTolabelPairHashTable& vertexMap, + labelList& cellMap, + const bool writeDelaunayData = true + ) const; }; diff --git a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshI.H b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshI.H index bad25b2b83..daecf18c58 100644 --- a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshI.H +++ b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshI.H @@ -25,17 +25,6 @@ License // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - template inline const Foam::Time& Foam::DelaunayMesh::time() const { @@ -70,23 +59,6 @@ void Foam::DelaunayMesh::timeCheck } -template -inline Foam::label Foam::DelaunayMesh::getNewVertexIndex() const -{ - label id = vertexCount_++; - - if (id == labelMax) - { - WarningIn - ( - "Foam::DelaunayMesh::getNewVertexIndex() const" - ) << "Vertex counter has overflowed." << endl; - } - - return id; -} - - template inline Foam::label Foam::DelaunayMesh::getNewCellIndex() const { @@ -105,16 +77,26 @@ inline Foam::label Foam::DelaunayMesh::getNewCellIndex() const template -Foam::label Foam::DelaunayMesh::cellCount() const +inline Foam::label Foam::DelaunayMesh::getNewVertexIndex() const { - return cellCount_; + label id = vertexCount_++; + + if (id == labelMax) + { + WarningIn + ( + "Foam::DelaunayMesh::getNewVertexIndex() const" + ) << "Vertex counter has overflowed." << endl; + } + + return id; } template -void Foam::DelaunayMesh::resetCellCount() +Foam::label Foam::DelaunayMesh::cellCount() const { - cellCount_ = 0; + return cellCount_; } @@ -125,6 +107,13 @@ Foam::label Foam::DelaunayMesh::vertexCount() const } +template +void Foam::DelaunayMesh::resetCellCount() +{ + cellCount_ = 0; +} + + template void Foam::DelaunayMesh::resetVertexCount() { @@ -132,22 +121,4 @@ void Foam::DelaunayMesh::resetVertexCount() } -// * * * * * * * * * * * * * * * Member Operators * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * * Friend Functions * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * * Friend Operators * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * IOstream Operators * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * * Ostream Operator * * * * * * * * * * * * * // - - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - // ************************************************************************* // diff --git a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C index 1a341348b1..d987a8ad4f 100644 --- a/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C +++ b/applications/utilities/mesh/generation/foamyHexMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C @@ -146,7 +146,8 @@ void Foam::DelaunayMesh::printInfo(Ostream& os) const ++vit ) { - if (!vit->farPoint()) + // Only internal or boundary vertices have a size + if (vit->internalOrBoundaryPoint()) { minSize = min(vit->targetCellSize(), minSize); maxSize = max(vit->targetCellSize(), maxSize); @@ -361,19 +362,19 @@ Foam::DelaunayMesh::createMesh // Calculate pts and a map of point index to location in pts. label vertI = 0; - labelIOField indices - ( - IOobject - ( - "indices", - time().timeName(), - name, - time(), - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - Triangulation::number_of_vertices() - ); +// labelIOField indices +// ( +// IOobject +// ( +// "indices", +// time().timeName(), +// name, +// time(), +// IOobject::NO_READ, +// IOobject::AUTO_WRITE +// ), +// Triangulation::number_of_vertices() +// ); labelIOField types ( @@ -414,7 +415,7 @@ Foam::DelaunayMesh::createMesh { vertexMap(labelPair(vit->index(), vit->procIndex())) = vertI; points[vertI] = topoint(vit->point()); - indices[vertI] = vit->index(); +// indices[vertI] = vit->index(); types[vertI] = static_cast