diff --git a/applications/solvers/combustion/XiFoam/PDRFoam/UEqn.H b/applications/solvers/combustion/XiFoam/PDRFoam/UEqn.H index 114131c94e..88674e781b 100644 --- a/applications/solvers/combustion/XiFoam/PDRFoam/UEqn.H +++ b/applications/solvers/combustion/XiFoam/PDRFoam/UEqn.H @@ -1,5 +1,3 @@ - MRF.correctBoundaryVelocity(U); - fvVectorMatrix UEqn ( betav*fvm::ddt(rho, U) + fvm::div(phi, U) diff --git a/applications/solvers/combustion/XiFoam/UEqn.H b/applications/solvers/combustion/XiFoam/UEqn.H index 1c08541677..a26acd7134 100644 --- a/applications/solvers/combustion/XiFoam/UEqn.H +++ b/applications/solvers/combustion/XiFoam/UEqn.H @@ -1,5 +1,3 @@ - MRF.correctBoundaryVelocity(U); - fvVectorMatrix UEqn ( fvm::ddt(rho, U) + fvm::div(phi, U) diff --git a/applications/solvers/compressible/rhoPorousSimpleFoam/UEqn.H b/applications/solvers/compressible/rhoPorousSimpleFoam/UEqn.H index cedba27681..f77aaf6106 100644 --- a/applications/solvers/compressible/rhoPorousSimpleFoam/UEqn.H +++ b/applications/solvers/compressible/rhoPorousSimpleFoam/UEqn.H @@ -1,7 +1,5 @@ // Construct the Momentum equation - MRF.correctBoundaryVelocity(U); - tmp tUEqn ( fvm::div(phi, U) diff --git a/applications/solvers/incompressible/SRFPimpleFoam/Make/files b/applications/solvers/incompressible/SRFPimpleFoam/Make/files deleted file mode 100644 index a15ee9be6a..0000000000 --- a/applications/solvers/incompressible/SRFPimpleFoam/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -SRFPimpleFoam.C - -EXE = $(FOAM_APPBIN)/SRFPimpleFoam diff --git a/applications/solvers/incompressible/SRFPimpleFoam/Make/options b/applications/solvers/incompressible/SRFPimpleFoam/Make/options deleted file mode 100644 index d138c73b43..0000000000 --- a/applications/solvers/incompressible/SRFPimpleFoam/Make/options +++ /dev/null @@ -1,17 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/MomentumTransportModels/momentumTransportModels/lnInclude \ - -I$(LIB_SRC)/MomentumTransportModels/incompressible/lnInclude \ - -I$(LIB_SRC)/physicalProperties/lnInclude \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/meshTools/lnInclude \ - -I$(LIB_SRC)/sampling/lnInclude - -EXE_LIBS = \ - -lmomentumTransportModels \ - -lincompressibleMomentumTransportModels \ - -lphysicalProperties \ - -lfiniteVolume \ - -lmeshTools \ - -lfvModels \ - -lfvConstraints \ - -lsampling diff --git a/applications/solvers/incompressible/SRFPimpleFoam/SRFPimpleFoam.C b/applications/solvers/incompressible/SRFPimpleFoam/SRFPimpleFoam.C deleted file mode 100644 index 78f753de8b..0000000000 --- a/applications/solvers/incompressible/SRFPimpleFoam/SRFPimpleFoam.C +++ /dev/null @@ -1,110 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 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 - SRFPimpleFoam - -Description - Large time-step transient solver for incompressible, turbulent flow in a - single rotating frame. - - Turbulence modelling is generic, i.e. laminar, RAS or LES may be selected. - -\*---------------------------------------------------------------------------*/ - -#include "fvCFD.H" -#include "viscosityModel.H" -#include "incompressibleMomentumTransportModels.H" -#include "pimpleControl.H" -#include "pressureReference.H" -#include "SRFModel.H" -#include "fvModels.H" -#include "fvConstraints.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -int main(int argc, char *argv[]) -{ - #include "postProcess.H" - - #include "setRootCaseLists.H" - #include "createTime.H" - #include "createMesh.H" - #include "createControl.H" - #include "createTimeControls.H" - #include "createFields.H" - #include "initContinuityErrs.H" - - turbulence->validate(); - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - Info<< "\nStarting time loop\n" << endl; - - while (pimple.run(runTime)) - { - #include "readTimeControls.H" - #include "CourantNo.H" - #include "setDeltaT.H" - - runTime++; - - Info<< "Time = " << runTime.userTimeName() << nl << endl; - - // --- Pressure-velocity PIMPLE corrector loop - while (pimple.loop()) - { - fvModels.correct(); - - #include "UrelEqn.H" - - // --- Pressure corrector loop - while (pimple.correct()) - { - #include "pEqn.H" - } - - // Update the absolute velocity - U = Urel + SRF->U(); - - if (pimple.turbCorr()) - { - viscosity->correct(); - turbulence->correct(); - } - } - - runTime.write(); - - Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" - << " ClockTime = " << runTime.elapsedClockTime() << " s" - << nl << endl; - } - - Info<< "End\n" << endl; - - return 0; -} - - -// ************************************************************************* // diff --git a/applications/solvers/incompressible/SRFPimpleFoam/UrelEqn.H b/applications/solvers/incompressible/SRFPimpleFoam/UrelEqn.H deleted file mode 100644 index 8b358bcaf9..0000000000 --- a/applications/solvers/incompressible/SRFPimpleFoam/UrelEqn.H +++ /dev/null @@ -1,19 +0,0 @@ - // Relative momentum predictor - tmp tUrelEqn - ( - fvm::ddt(Urel) - + fvm::div(phi, Urel) - + turbulence->divDevSigma(Urel) - + SRF->Su() - == - fvModels.source(Urel) - ); - fvVectorMatrix& UrelEqn = tUrelEqn.ref(); - - UrelEqn.relax(); - - fvConstraints.constrain(UrelEqn); - - solve(UrelEqn == -fvc::grad(p)); - - fvConstraints.constrain(Urel); diff --git a/applications/solvers/incompressible/SRFPimpleFoam/createFields.H b/applications/solvers/incompressible/SRFPimpleFoam/createFields.H deleted file mode 100644 index 94c7aaba32..0000000000 --- a/applications/solvers/incompressible/SRFPimpleFoam/createFields.H +++ /dev/null @@ -1,75 +0,0 @@ -Info<< "Reading field p\n" << endl; -volScalarField p -( - IOobject - ( - "p", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh -); - -Info<< "Reading field Urel\n" << endl; -volVectorField Urel -( - IOobject - ( - "Urel", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh -); - -Info<< "Reading/calculating face flux field phi\n" << endl; -surfaceScalarField phi -( - IOobject - ( - "phi", - runTime.timeName(), - mesh, - IOobject::READ_IF_PRESENT, - IOobject::AUTO_WRITE - ), - linearInterpolate(Urel) & mesh.Sf() -); - -pressureReference pressureReference(p, pimple.dict()); -mesh.schemes().setFluxRequired(p.name()); - -Info<< "Creating SRF model\n" << endl; -autoPtr SRF -( - SRF::SRFModel::New(Urel) -); - -// Create the absolute velocity -volVectorField U -( - IOobject - ( - "U", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - Urel + SRF->U() -); - - -autoPtr viscosity(viscosityModel::New(mesh)); - -autoPtr turbulence -( - incompressible::momentumTransportModel::New(U, phi, viscosity) -); - -#include "createFvModels.H" -#include "createFvConstraints.H" diff --git a/applications/solvers/incompressible/SRFPimpleFoam/pEqn.H b/applications/solvers/incompressible/SRFPimpleFoam/pEqn.H deleted file mode 100644 index e678c78e54..0000000000 --- a/applications/solvers/incompressible/SRFPimpleFoam/pEqn.H +++ /dev/null @@ -1,62 +0,0 @@ -volScalarField rAUrel(1.0/UrelEqn.A()); -volVectorField HbyA("HbyA", Urel); -HbyA = rAUrel*UrelEqn.H(); - -surfaceScalarField phiHbyA -( - "phiHbyA", - fvc::flux(HbyA) - + fvc::interpolate(rAUrel)*fvc::ddtCorr(Urel, phi) -); - -adjustPhi(phiHbyA, Urel, p); - -tmp rAtUrel(rAUrel); - -if (pimple.consistent()) -{ - rAtUrel = 1.0/max(1.0/rAUrel - UrelEqn.H1(), 0.1/rAUrel); - phiHbyA += - fvc::interpolate(rAtUrel() - rAUrel)*fvc::snGrad(p)*mesh.magSf(); - HbyA -= (rAUrel - rAtUrel())*fvc::grad(p); -} - -if (pimple.nCorrPiso() <= 1) -{ - tUrelEqn.clear(); -} - -// Update the pressure BCs to ensure flux consistency -constrainPressure(p, Urel, phiHbyA, rAtUrel()); - -// Non-orthogonal pressure corrector loop -while (pimple.correctNonOrthogonal()) -{ - // Pressure corrector - fvScalarMatrix pEqn - ( - fvm::laplacian(rAtUrel(), p) == fvc::div(phiHbyA) - ); - - pEqn.setReference - ( - pressureReference.refCell(), - pressureReference.refValue() - ); - - pEqn.solve(); - - if (pimple.finalNonOrthogonalIter()) - { - phi = phiHbyA - pEqn.flux(); - } -} - -#include "continuityErrs.H" - -p.relax(); - -// Momentum corrector -Urel = HbyA - rAtUrel()*fvc::grad(p); -Urel.correctBoundaryConditions(); -fvConstraints.constrain(Urel); diff --git a/applications/solvers/incompressible/SRFSimpleFoam/Make/files b/applications/solvers/incompressible/SRFSimpleFoam/Make/files deleted file mode 100644 index 3250f4139d..0000000000 --- a/applications/solvers/incompressible/SRFSimpleFoam/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -SRFSimpleFoam.C - -EXE = $(FOAM_APPBIN)/SRFSimpleFoam diff --git a/applications/solvers/incompressible/SRFSimpleFoam/Make/options b/applications/solvers/incompressible/SRFSimpleFoam/Make/options deleted file mode 100644 index d138c73b43..0000000000 --- a/applications/solvers/incompressible/SRFSimpleFoam/Make/options +++ /dev/null @@ -1,17 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/MomentumTransportModels/momentumTransportModels/lnInclude \ - -I$(LIB_SRC)/MomentumTransportModels/incompressible/lnInclude \ - -I$(LIB_SRC)/physicalProperties/lnInclude \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/meshTools/lnInclude \ - -I$(LIB_SRC)/sampling/lnInclude - -EXE_LIBS = \ - -lmomentumTransportModels \ - -lincompressibleMomentumTransportModels \ - -lphysicalProperties \ - -lfiniteVolume \ - -lmeshTools \ - -lfvModels \ - -lfvConstraints \ - -lsampling diff --git a/applications/solvers/incompressible/SRFSimpleFoam/SRFSimpleFoam.C b/applications/solvers/incompressible/SRFSimpleFoam/SRFSimpleFoam.C deleted file mode 100644 index 5d90a8e01b..0000000000 --- a/applications/solvers/incompressible/SRFSimpleFoam/SRFSimpleFoam.C +++ /dev/null @@ -1,91 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 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 - SRFSimpleFoam - -Description - Steady-state solver for incompressible, turbulent flow of non-Newtonian - fluids in a single rotating frame. - -\*---------------------------------------------------------------------------*/ - -#include "fvCFD.H" -#include "viscosityModel.H" -#include "incompressibleMomentumTransportModels.H" -#include "SRFModel.H" -#include "simpleControl.H" -#include "pressureReference.H" -#include "fvModels.H" -#include "fvConstraints.H" - -// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - -int main(int argc, char *argv[]) -{ - #include "postProcess.H" - - #include "setRootCaseLists.H" - #include "createTime.H" - #include "createMesh.H" - #include "createControl.H" - #include "createFields.H" - #include "initContinuityErrs.H" - - turbulence->validate(); - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - Info<< "\nStarting time loop\n" << endl; - - while (simple.loop(runTime)) - { - Info<< "Time = " << runTime.userTimeName() << nl << endl; - - fvModels.correct(); - - // --- Pressure-velocity SIMPLE corrector - { - #include "UrelEqn.H" - #include "pEqn.H" - } - - U = Urel + SRF->U(); - - viscosity->correct(); - turbulence->correct(); - - runTime.write(); - - Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" - << " ClockTime = " << runTime.elapsedClockTime() << " s" - << nl << endl; - } - - Info<< "End\n" << endl; - - return 0; -} - - -// ************************************************************************* // diff --git a/applications/solvers/incompressible/SRFSimpleFoam/UrelEqn.H b/applications/solvers/incompressible/SRFSimpleFoam/UrelEqn.H deleted file mode 100644 index 46491fb3cf..0000000000 --- a/applications/solvers/incompressible/SRFSimpleFoam/UrelEqn.H +++ /dev/null @@ -1,22 +0,0 @@ - // Relative momentum predictor - - tmp tUrelEqn - ( - fvm::div(phi, Urel) - + turbulence->divDevSigma(Urel) - + SRF->Su() - == - fvModels.source(Urel) - ); - fvVectorMatrix& UrelEqn = tUrelEqn.ref(); - - UrelEqn.relax(); - - fvConstraints.constrain(UrelEqn); - - if (simple.momentumPredictor()) - { - solve(UrelEqn == -fvc::grad(p)); - - fvConstraints.constrain(Urel); - } diff --git a/applications/solvers/incompressible/SRFSimpleFoam/createFields.H b/applications/solvers/incompressible/SRFSimpleFoam/createFields.H deleted file mode 100644 index 62a3ee0fec..0000000000 --- a/applications/solvers/incompressible/SRFSimpleFoam/createFields.H +++ /dev/null @@ -1,73 +0,0 @@ -Info<< "Reading field p\n" << endl; -volScalarField p -( - IOobject - ( - "p", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh -); - -Info<< "Reading field Urel\n" << endl; -volVectorField Urel -( - IOobject - ( - "Urel", - runTime.timeName(), - mesh, - IOobject::MUST_READ, - IOobject::AUTO_WRITE - ), - mesh -); - -Info<< "Reading/calculating face flux field phi\n" << endl; -surfaceScalarField phi -( - IOobject - ( - "phi", - runTime.timeName(), - mesh, - IOobject::READ_IF_PRESENT, - IOobject::AUTO_WRITE - ), - linearInterpolate(Urel) & mesh.Sf() -); - -pressureReference pressureReference(p, simple.dict()); - -mesh.schemes().setFluxRequired(p.name()); - -Info<< "Creating SRF model\n" << endl; -autoPtr SRF(SRF::SRFModel::New(Urel)); - -// Construct the absolute velocity -volVectorField U -( - IOobject - ( - "U", - runTime.timeName(), - mesh, - IOobject::NO_READ, - IOobject::AUTO_WRITE - ), - Urel + SRF->U() -); - - -autoPtr viscosity(viscosityModel::New(mesh)); - -autoPtr turbulence -( - incompressible::momentumTransportModel::New(U, phi, viscosity) -); - -#include "createFvModels.H" -#include "createFvConstraints.H" diff --git a/applications/solvers/incompressible/SRFSimpleFoam/pEqn.H b/applications/solvers/incompressible/SRFSimpleFoam/pEqn.H deleted file mode 100644 index 5af5c25231..0000000000 --- a/applications/solvers/incompressible/SRFSimpleFoam/pEqn.H +++ /dev/null @@ -1,55 +0,0 @@ -{ - volScalarField rAUrel(1.0/UrelEqn.A()); - volVectorField HbyA("HbyA", Urel); - HbyA = rAUrel*UrelEqn.H(); - - surfaceScalarField phiHbyA("phiHbyA", fvc::flux(HbyA)); - adjustPhi(phiHbyA, Urel, p); - - tmp rAtUrel(rAUrel); - - if (simple.consistent()) - { - rAtUrel = 1.0/(1.0/rAUrel - UrelEqn.H1()); - phiHbyA += - fvc::interpolate(rAtUrel() - rAUrel)*fvc::snGrad(p)*mesh.magSf(); - HbyA -= (rAUrel - rAtUrel())*fvc::grad(p); - } - - tUrelEqn.clear(); - - // Update the pressure BCs to ensure flux consistency - constrainPressure(p, Urel, phiHbyA, rAtUrel()); - - // Non-orthogonal pressure corrector loop - while (simple.correctNonOrthogonal()) - { - fvScalarMatrix pEqn - ( - fvm::laplacian(rAtUrel(), p) == fvc::div(phiHbyA) - ); - - pEqn.setReference - ( - pressureReference.refCell(), - pressureReference.refValue() - ); - - pEqn.solve(); - - if (simple.finalNonOrthogonalIter()) - { - phi = phiHbyA - pEqn.flux(); - } - } - - #include "continuityErrs.H" - - // Explicitly relax pressure for momentum corrector - p.relax(); - - // Momentum corrector - Urel = HbyA - rAtUrel()*fvc::grad(p); - Urel.correctBoundaryConditions(); - fvConstraints.constrain(Urel); -} diff --git a/applications/solvers/incompressible/porousSimpleFoam/UEqn.H b/applications/solvers/incompressible/porousSimpleFoam/UEqn.H index d831d55fb8..9286158749 100644 --- a/applications/solvers/incompressible/porousSimpleFoam/UEqn.H +++ b/applications/solvers/incompressible/porousSimpleFoam/UEqn.H @@ -1,7 +1,5 @@ // Construct the Momentum equation - MRF.correctBoundaryVelocity(U); - tmp tUEqn ( fvm::div(phi, U) diff --git a/applications/solvers/incompressible/simpleFoam/UEqn.H b/applications/solvers/incompressible/simpleFoam/UEqn.H index 16ba8b5e55..86306adef9 100644 --- a/applications/solvers/incompressible/simpleFoam/UEqn.H +++ b/applications/solvers/incompressible/simpleFoam/UEqn.H @@ -1,7 +1,5 @@ // Momentum predictor - MRF.correctBoundaryVelocity(U); - tmp tUEqn ( fvm::div(phi, U) diff --git a/applications/solvers/modules/fluid/fluidSolver/Make/options b/applications/solvers/modules/fluid/fluidSolver/Make/options index 4544d945fd..c330dbfc7a 100644 --- a/applications/solvers/modules/fluid/fluidSolver/Make/options +++ b/applications/solvers/modules/fluid/fluidSolver/Make/options @@ -1,4 +1,4 @@ -EXE_INC = -ggdb3 \ +EXE_INC = \ -I$(LIB_SRC)/MomentumTransportModels/momentumTransportModels/lnInclude \ -I$(LIB_SRC)/MomentumTransportModels/incompressible/lnInclude \ -I$(LIB_SRC)/physicalProperties/lnInclude \ diff --git a/applications/solvers/modules/fluid/incompressibleFluid/momentumPredictor.C b/applications/solvers/modules/fluid/incompressibleFluid/momentumPredictor.C index 76fb1750bd..48796235e3 100644 --- a/applications/solvers/modules/fluid/incompressibleFluid/momentumPredictor.C +++ b/applications/solvers/modules/fluid/incompressibleFluid/momentumPredictor.C @@ -29,8 +29,6 @@ License void Foam::solvers::incompressibleFluid::momentumPredictor() { - MRF.correctBoundaryVelocity(U); - tUEqn = ( fvm::ddt(U) + fvm::div(phi, U) diff --git a/applications/solvers/modules/fluid/isothermalFluid/momentumPredictor.C b/applications/solvers/modules/fluid/isothermalFluid/momentumPredictor.C index 967b761fe5..e23eca03d0 100644 --- a/applications/solvers/modules/fluid/isothermalFluid/momentumPredictor.C +++ b/applications/solvers/modules/fluid/isothermalFluid/momentumPredictor.C @@ -29,8 +29,6 @@ License void Foam::solvers::isothermalFluid::momentumPredictor() { - MRF.correctBoundaryVelocity(U); - tUEqn = ( fvm::ddt(rho, U) + fvm::div(phi, U) diff --git a/applications/solvers/multiphase/compressibleInterFoam/VoFSolidificationMeltingSource/VoFSolidificationMeltingSource.C b/applications/solvers/multiphase/compressibleInterFoam/VoFSolidificationMeltingSource/VoFSolidificationMeltingSource.C index 2cb983a7f9..e83ce33d1d 100644 --- a/applications/solvers/multiphase/compressibleInterFoam/VoFSolidificationMeltingSource/VoFSolidificationMeltingSource.C +++ b/applications/solvers/multiphase/compressibleInterFoam/VoFSolidificationMeltingSource/VoFSolidificationMeltingSource.C @@ -86,7 +86,7 @@ Foam::fv::VoFSolidificationMeltingSource::VoFSolidificationMeltingSource ) : fvModel(name, modelType, dict, mesh), - set_(coeffs(), mesh), + set_(mesh, coeffs()), alphaSolidT_(), L_("L", dimEnergy/dimMass, NaN), relax_(NaN), diff --git a/applications/solvers/multiphase/driftFluxFoam/incompressibleTwoPhaseInteractingMixture/incompressibleTwoPhaseInteractingMixture.C b/applications/solvers/multiphase/driftFluxFoam/incompressibleTwoPhaseInteractingMixture/incompressibleTwoPhaseInteractingMixture.C index c4fb800b86..8baea1cdb8 100644 --- a/applications/solvers/multiphase/driftFluxFoam/incompressibleTwoPhaseInteractingMixture/incompressibleTwoPhaseInteractingMixture.C +++ b/applications/solvers/multiphase/driftFluxFoam/incompressibleTwoPhaseInteractingMixture/incompressibleTwoPhaseInteractingMixture.C @@ -224,7 +224,6 @@ Foam::incompressibleTwoPhaseInteractingMixture::divTauDm() const void Foam::incompressibleTwoPhaseInteractingMixture::correct() { - MRF_.correctBoundaryVelocity(U_); mu_ = muModel_->mu(rhoc_*nucModel_->nu(), U_); UdmModel_->correct(); } diff --git a/applications/solvers/multiphase/interFoam/UEqn.H b/applications/solvers/multiphase/interFoam/UEqn.H index b3317395c4..508bf78f82 100644 --- a/applications/solvers/multiphase/interFoam/UEqn.H +++ b/applications/solvers/multiphase/interFoam/UEqn.H @@ -1,5 +1,3 @@ - MRF.correctBoundaryVelocity(U); - fvVectorMatrix UEqn ( fvm::ddt(rho, U) + fvm::div(rhoPhi, U) diff --git a/applications/solvers/multiphase/interFoam/interMixingFoam/UEqn.H b/applications/solvers/multiphase/interFoam/interMixingFoam/UEqn.H index 984ac6f757..fb1fd9a51c 100644 --- a/applications/solvers/multiphase/interFoam/interMixingFoam/UEqn.H +++ b/applications/solvers/multiphase/interFoam/interMixingFoam/UEqn.H @@ -1,5 +1,3 @@ - MRF.correctBoundaryVelocity(U); - fvVectorMatrix UEqn ( fvm::ddt(rho, U) + fvm::div(rhoPhi, U) diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/phaseSystems/phaseModel/MovingPhaseModel/MovingPhaseModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/phaseSystems/phaseModel/MovingPhaseModel/MovingPhaseModel.C index 68e1574e0a..210180e6cf 100644 --- a/applications/solvers/multiphase/multiphaseEulerFoam/phaseSystems/phaseModel/MovingPhaseModel/MovingPhaseModel.C +++ b/applications/solvers/multiphase/multiphaseEulerFoam/phaseSystems/phaseModel/MovingPhaseModel/MovingPhaseModel.C @@ -241,7 +241,6 @@ template void Foam::MovingPhaseModel::correct() { BasePhaseModel::correct(); - this->fluid().MRF().correctBoundaryVelocity(U_); } diff --git a/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H b/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H index 984ac6f757..fb1fd9a51c 100644 --- a/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H +++ b/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H @@ -1,5 +1,3 @@ - MRF.correctBoundaryVelocity(U); - fvVectorMatrix UEqn ( fvm::ddt(rho, U) + fvm::div(rhoPhi, U) diff --git a/applications/solvers/multiphase/potentialFreeSurfaceFoam/UEqn.H b/applications/solvers/multiphase/potentialFreeSurfaceFoam/UEqn.H index 2db0e87069..1234a78660 100644 --- a/applications/solvers/multiphase/potentialFreeSurfaceFoam/UEqn.H +++ b/applications/solvers/multiphase/potentialFreeSurfaceFoam/UEqn.H @@ -1,5 +1,3 @@ -MRF.correctBoundaryVelocity(U); - tmp tUEqn ( fvm::ddt(U) + fvm::div(phi, U) diff --git a/bin/SRFPimpleFoam b/bin/SRFPimpleFoam new file mode 100755 index 0000000000..8ce27ad309 --- /dev/null +++ b/bin/SRFPimpleFoam @@ -0,0 +1,61 @@ +#!/bin/sh +#------------------------------------------------------------------------------ +# ========= | +# \\ / F ield | OpenFOAM: The Open Source CFD Toolbox +# \\ / O peration | Website: https://openfoam.org +# \\ / A nd | Copyright (C) 2022 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 . +# +# Script +# SRFPimpleFoam +# +# Description +# Script to inform the user that SRFPimpleFoam has been superseded +# and replaced by the more general incompressibleFluid solver module +# executed by the foamRun application. +# +#------------------------------------------------------------------------------ + +cat <. +# +# Script +# SRFSimpleFoam +# +# Description +# Script to inform the user that SRFSimpleFoam has been superseded +# and replaced by the more general incompressibleFluid solver module +# executed by the foamRun application. +# +#------------------------------------------------------------------------------ + +cat <(pp)) { forAll(pp, i) { @@ -98,33 +91,15 @@ void Foam::MRFZone::setMRFFaces() if (zoneCell[own[facei]]) { - faceType[facei] = 2; - nZoneFaces++; - } - } - } - else if (!isA(pp)) - { - forAll(pp, i) - { - const label facei = pp.start() + i; - - if (zoneCell[own[facei]]) - { - faceType[facei] = 1; + faceInMRF[facei] = true; nZoneFaces++; } } } } - // Synchronise the faceType across processor patches - syncTools::syncFaceList(mesh_, faceType, maxEqOp