diff --git a/src/waveModels/Make/files b/src/waveModels/Make/files index 67333fa8212da6bf46a5c56b6b6d02f53b6855db..44b6ad45c1ad9178126cf37df0957f1a63849e4c 100644 --- a/src/waveModels/Make/files +++ b/src/waveModels/Make/files @@ -6,6 +6,8 @@ waveGenerationModels/base/regularWaveModel/regularWaveModel.C waveGenerationModels/base/solitaryWaveModel/solitaryWaveModel.C waveGenerationModels/derived/Boussinesq/BoussinesqWaveModel.C waveGenerationModels/derived/cnoidal/cnoidalWaveModel.C +waveGenerationModels/derived/Grimshaw/GrimshawWaveModel.C +waveGenerationModels/derived/McCowan/McCowanWaveModel.C waveGenerationModels/derived/StokesII/StokesIIWaveModel.C waveGenerationModels/derived/StokesI/StokesIWaveModel.C waveGenerationModels/derived/StokesV/StokesVWaveModel.C diff --git a/src/waveModels/waveGenerationModels/derived/Grimshaw/GrimshawWaveModel.C b/src/waveModels/waveGenerationModels/derived/Grimshaw/GrimshawWaveModel.C new file mode 100644 index 0000000000000000000000000000000000000000..4086598f3443af4c3b1e92e79d0d1c38865bb49b --- /dev/null +++ b/src/waveModels/waveGenerationModels/derived/Grimshaw/GrimshawWaveModel.C @@ -0,0 +1,257 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2017 OpenCFD Ltd. + \\/ M anipulation | Copyright (C) 2017 IH-Cantabria +------------------------------------------------------------------------------- +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 <http://www.gnu.org/licenses/>. + +\*---------------------------------------------------------------------------*/ + +#include "GrimshawWaveModel.H" +#include "addToRunTimeSelectionTable.H" + +// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // + +namespace Foam +{ +namespace waveModels +{ + defineTypeNameAndDebug(Grimshaw, 0); + addToRunTimeSelectionTable + ( + waveModel, + Grimshaw, + patch + ); +} +} + + +// * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * * // + +Foam::scalar Foam::waveModels::Grimshaw::alfa +( + const scalar H, + const scalar h +) const +{ + scalar eps = H/h; + + return sqrt(0.75*eps)*(1.0 - 0.625*eps + (71.0/128.0)*eps*eps); +} + + +Foam::scalar Foam::waveModels::Grimshaw::eta +( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0 +) const +{ + const scalar eps = H/h; + const scalar eps2 = eps*eps; + const scalar eps3 = eps*eps2; + + const scalar C = sqrt(mag(g_)*h)*sqrt(1.0 + eps - 0.05*eps2 - (3.0/70.0)*eps3); + + const scalar ts = 3.5*h/sqrt(H/h); + const scalar xa = -C*t + ts - X0 + x*cos(theta) + y*sin(theta); + const scalar alfa = this->alfa(H, h); + + const scalar s = (1.0)/(cosh(alfa*(xa/h))); + const scalar s2 = s*s; + const scalar q = tanh(alfa*(xa/h)); + const scalar q2 = q*q; + + return + h + *( + eps*s2 + - 0.75*eps2*s2*q2 + + eps3*(0.625*s2*q2 - 1.2625*s2*s2*q2) + ); +} + + +Foam::vector Foam::waveModels::Grimshaw::Uf +( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0, + const scalar z +) const +{ + const scalar eps = H/h; + const scalar eps2 = eps*eps; + const scalar eps3 = eps*eps2; + + const scalar C = sqrt(mag(g_)*h)*sqrt(1.0 + eps - 0.05*eps2 - (3.0/70.0)*eps3); + + const scalar ts = 3.5*h/sqrt(eps); + const scalar xa = -C*t + ts - X0 + x*cos(theta) + y*sin(theta); + const scalar alfa = this->alfa(H, h); + + const scalar s = (1.0)/(cosh(alfa*(xa/h))); + const scalar s2 = s*s; + const scalar s4 = s2*s2; + const scalar s6 = s2*s4; + + const scalar zbyh = z/h; + const scalar zbyh2 = zbyh*zbyh; + const scalar zbyh4 = zbyh2*zbyh2; + + scalar outa = eps*s2 - eps2*(-0.25*s2 + s4 + zbyh2*(1.5*s2 - 2.25*s4)); + scalar outb = 0.475*s2 + 0.2*s4 - 1.2*s6; + scalar outc = zbyh2*(-1.5*s2 - 3.75*s4 + 7.5*s6); + scalar outd = zbyh4*(-0.375*s2 + (45.0/16.0)*s4 - (45.0/16.0)*s6); + + scalar u = sqrt(mag(g_)*h)*(outa - eps3*(outb + outc + outd)); + + outa = eps*s2 - eps2*(0.375*s2 + 2*s4 + zbyh2*(0.5*s2 - 1.5*s4)); + outb = (49.0/640.0)*s2 - 0.85*s4 - 3.6*s6; + outc = zbyh2*((-13.0/16.0)*s2 -(25.0/16.0)*s4 + 7.5*s6); + outd = zbyh4*(-0.075*s2 -1.125*s4 - (27.0/16.0)*s6); + + const scalar w = sqrt(mag(g_)*h)*(outa - eps3*(outb + outc + outd)); + + const scalar v = u*sin(waveAngle_); + u *= cos(waveAngle_); + + return vector(u, v, w); +} + + +void Foam::waveModels::Grimshaw::setLevel +( + const scalar t, + const scalar tCoeff, + scalarField& level +) const +{ + forAll(level, paddlei) + { + const scalar eta = + this->eta + ( + waveHeight_, + waterDepthRef_, + xPaddle_[paddlei], + yPaddle_[paddlei], + waveAngle_, + t, + x0_ + ); + + level[paddlei] = waterDepthRef_ + tCoeff*eta; + } +} + + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam::waveModels::Grimshaw::Grimshaw +( + const dictionary& dict, + const fvMesh& mesh, + const polyPatch& patch, + const bool readFields +) +: + solitaryWaveModel(dict, mesh, patch, false) +{ + if (readFields) + { + readDict(dict); + } +} + + +// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // + +Foam::waveModels::Grimshaw::~Grimshaw() +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +bool Foam::waveModels::Grimshaw::readDict(const dictionary& overrideDict) +{ + if (solitaryWaveModel::readDict(overrideDict)) + { + return true; + } + + return false; +} + + +void Foam::waveModels::Grimshaw::setVelocity +( + const scalar t, + const scalar tCoeff, + const scalarField& level +) +{ + forAll(U_, facei) + { + // Fraction of geometry represented by paddle - to be set + scalar fraction = 1; + + // Height - to be set + scalar z = 0; + + setPaddlePropeties(level, facei, fraction, z); + + if (fraction > 0) + { + const label paddlei = faceToPaddle_[facei]; + + const vector Uf = this->Uf + ( + waveHeight_, + waterDepthRef_, + xPaddle_[paddlei], + yPaddle_[paddlei], + waveAngle_, + t, + x0_, + z + ); + + U_[facei] = fraction*Uf*tCoeff; + } + } +} + + +void Foam::waveModels::Grimshaw::info(Ostream& os) const +{ + solitaryWaveModel::info(os); +} + + +// ************************************************************************* // diff --git a/src/waveModels/waveGenerationModels/derived/Grimshaw/GrimshawWaveModel.H b/src/waveModels/waveGenerationModels/derived/Grimshaw/GrimshawWaveModel.H new file mode 100644 index 0000000000000000000000000000000000000000..34ed47c7fe3b4cd80a375e29b4d5a1b123f933b6 --- /dev/null +++ b/src/waveModels/waveGenerationModels/derived/Grimshaw/GrimshawWaveModel.H @@ -0,0 +1,141 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2017 OpenCFD Ltd. + \\/ M anipulation | Copyright (C) 2017 IH-Cantabria +------------------------------------------------------------------------------- +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 <http://www.gnu.org/licenses/>. + +Class + Foam::waveModels::Grimshaw + +Description + Grimshaw wave model + +\*---------------------------------------------------------------------------*/ + +#ifndef waveModels_Grimshaw_H +#define waveModels_Grimshaw_H + +#include "solitaryWaveModel.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ +namespace waveModels +{ + +/*---------------------------------------------------------------------------*\ + Class Grimshaw Declaration +\*---------------------------------------------------------------------------*/ + +class Grimshaw +: + public solitaryWaveModel +{ +protected: + + // Protected Member Functions + + //- Wave height + virtual scalar eta + ( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0 + ) const; + + //- + virtual scalar alfa + ( + const scalar H, + const scalar h + ) const; + + //- Wave velocity + virtual vector Uf + ( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0, + const scalar z + ) const; + + //- Set the water level + virtual void setLevel + ( + const scalar t, + const scalar tCoeff, + scalarField& level + ) const; + + //- Calculate the wave model velocity + virtual void setVelocity + ( + const scalar t, + const scalar tCoeff, + const scalarField& level + ); + + +public: + + //- Runtime type information + TypeName("Grimshaw"); + + //- Constructor + Grimshaw + ( + const dictionary& dict, + const fvMesh& mesh, + const polyPatch& patch, + const bool readFields = true + ); + + //- Destructor + virtual ~Grimshaw(); + + + // Public Member Functions + + //- Read from dictionary + virtual bool readDict(const dictionary& overrideDict); + + //- Info + virtual void info(Ostream& os) const; +}; + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace waveModels +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/src/waveModels/waveGenerationModels/derived/McCowan/McCowanWaveModel.C b/src/waveModels/waveGenerationModels/derived/McCowan/McCowanWaveModel.C new file mode 100644 index 0000000000000000000000000000000000000000..6ef4fd3f9419ebb239261b5b00b307d37e0779f6 --- /dev/null +++ b/src/waveModels/waveGenerationModels/derived/McCowan/McCowanWaveModel.C @@ -0,0 +1,349 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2017 OpenCFD Ltd. + \\/ M anipulation | Copyright (C) 2017 IH-Cantabria +------------------------------------------------------------------------------- +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 <http://www.gnu.org/licenses/>. + +\*---------------------------------------------------------------------------*/ + +#include "McCowanWaveModel.H" +#include "addToRunTimeSelectionTable.H" + +// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // + +namespace Foam +{ +namespace waveModels +{ + defineTypeNameAndDebug(McCowan, 0); + addToRunTimeSelectionTable + ( + waveModel, + McCowan, + patch + ); +} +} + + +// * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * * // + +Foam::scalar Foam::waveModels::McCowan::eta +( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0 +) const +{ + vector vec = this->mn(H, h); + scalar mm = vec[0]; + scalar nn = vec[1]; + + scalar C = sqrt(((mag(g_)*h)/mm)*tan(mm)); + scalar ts = 3.5*h/sqrt(H/h); + scalar Xa = -C*t + ts - X0 + x*cos(theta) + y*sin(theta); + + scalar xin = 0.5*H; + scalar etas = newtonRapsonF2(xin, H, h, Xa, mm, nn); + return etas; +} + + +Foam::vector Foam::waveModels::McCowan::mn +( + const scalar H, + const scalar h +) const +{ + // m + scalar xin = 1; + scalar m = newtonRapsonF1(xin, H, h); + + // n + scalar c1 = sin(m + (1.0 + (2.0*H/(3.0*h)))); + scalar n = (2.0/3.0)*sqr(c1); + + return vector(m, n, n); +} + + +Foam::scalar Foam::waveModels::McCowan::newtonRapsonF1 +( + const scalar x0, + const scalar H, + const scalar h +) const +{ + label N = 10000; + scalar eps = 1.e-5; + scalar maxval = 10000.0; + + label iter = 1; + scalar x = x0; + scalar residual = 0; + while (iter <= N) + { + // f + scalar a = x + 1.0 + 2.0*H/(3.0*h); + scalar b = 0.5*x*(1.0 + H/h); + scalar c = 0.5*x*(1.0 + h/H); + scalar c1 = sin(a); + scalar fx = (2.0/3.0)*sqr(c1) - x*H/(h*tan(b)); + + residual = mag(fx); + + if (residual < eps) + { + return x; + } + else if ((iter > 1) && (residual > maxval)) + { + FatalErrorInFunction + << "Newton-Raphson iterations diverging: " + << "iterations = " << iter + << ", residual = " << residual + << exit(FatalError); + } + + // f-prime + scalar c2 = 1.0/tan(c); + scalar c3 = 1.0/sin(b); + + scalar fprime = (4.0/3.0)*c1*cos(a) - c2*h/H - b*sqr(c3); + + x -= fx/fprime; + iter++; + } + + WarningInFunction + << "Failed to converge in " << iter << " iterations. Residual = " + << residual << nl << endl; + + return x; +} + + +Foam::scalar Foam::waveModels::McCowan::newtonRapsonF2 +( + const scalar x0, + const scalar H, + const scalar h, + const scalar xa, + const scalar m, + const scalar n +) const +{ + label N = 10000; + scalar eps = 1.e-5; + scalar maxval = 10000; + + label iter = 1; + scalar x = x0; + scalar residual = 0; + while (iter <= N) + { + // f + scalar a = m*(1.0 + x/h); + scalar c1 = cos(a); + scalar c2 = sin(a); + + scalar fx = x - (h*n/m*(c2/(c1 + cosh(m*xa/h)))); + + residual = mag(fx); + + if (residual < eps) + { + return x; + } + else if ((iter > 1) && (residual > maxval)) + { + FatalErrorInFunction + << "Newton-Raphson iterations diverging: " + << "iterations = " << iter + << ", residual = " << residual + << exit(FatalError); + } + + // f-prime + scalar c3 = cosh(xa*m/h) + c1; + scalar fprime = 1 - n/c3*(c1 - sqr(c2)/c3); + + x -= fx/fprime; + iter++; + } + + WarningInFunction + << "Failed to converge in " << iter << " iterations. Residual = " + << residual << nl << endl; + + return x; +} + + +Foam::vector Foam::waveModels::McCowan::Uf +( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0, + const scalar z +) const +{ + const vector vec = this->mn(H, h); + const scalar mm = vec[0]; + const scalar nn = vec[1]; + + const scalar C = sqrt((mag(g_)*h)/mm*tan(mm)); + const scalar ts = 3.5*h/sqrt(H/h); + const scalar Xa = -C*t + ts - X0 + x*cos(theta) + y*sin(theta); + + scalar outa = C*nn*(1.0 + cos(mm*z/h)*cosh(mm*Xa/h)); + scalar outb = sqr(cos(mm*z/h) + cosh(mm*Xa/h)); + + scalar u = outa/outb; + + outa = C*nn*sin(mm*z/h)*sinh(mm*Xa/h); + + const scalar w = outa/outb; + + const scalar v = u*sin(waveAngle_); + u *= cos(waveAngle_); + + return vector(u, v, w); +} + + +void Foam::waveModels::McCowan::setLevel +( + const scalar t, + const scalar tCoeff, + scalarField& level +) const +{ + forAll(level, paddlei) + { + const scalar eta = + this->eta + ( + waveHeight_, + waterDepthRef_, + xPaddle_[paddlei], + yPaddle_[paddlei], + waveAngle_, + t, + x0_ + ); + + level[paddlei] = waterDepthRef_ + tCoeff*eta; + } +} + + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam::waveModels::McCowan::McCowan +( + const dictionary& dict, + const fvMesh& mesh, + const polyPatch& patch, + const bool readFields +) +: + solitaryWaveModel(dict, mesh, patch, false) +{ + if (readFields) + { + readDict(dict); + } +} + + +// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // + +Foam::waveModels::McCowan::~McCowan() +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +bool Foam::waveModels::McCowan::readDict(const dictionary& overrideDict) +{ + if (solitaryWaveModel::readDict(overrideDict)) + { + return true; + } + + return false; +} + + +void Foam::waveModels::McCowan::setVelocity +( + const scalar t, + const scalar tCoeff, + const scalarField& level +) +{ + forAll(U_, facei) + { + // Fraction of geometry represented by paddle - to be set + scalar fraction = 1; + + // Height - to be set + scalar z = 0; + + setPaddlePropeties(level, facei, fraction, z); + + if (fraction > 0) + { + const label paddlei = faceToPaddle_[facei]; + + const vector Uf = this->Uf + ( + waveHeight_, + waterDepthRef_, + xPaddle_[paddlei], + yPaddle_[paddlei], + waveAngle_, + t, + x0_, + z + ); + + U_[facei] = fraction*Uf*tCoeff; + } + } +} + + +void Foam::waveModels::McCowan::info(Ostream& os) const +{ + solitaryWaveModel::info(os); +} + + +// ************************************************************************* // diff --git a/src/waveModels/waveGenerationModels/derived/McCowan/McCowanWaveModel.H b/src/waveModels/waveGenerationModels/derived/McCowan/McCowanWaveModel.H new file mode 100644 index 0000000000000000000000000000000000000000..0ad144bea031644e9bbe596920737d845cdc6517 --- /dev/null +++ b/src/waveModels/waveGenerationModels/derived/McCowan/McCowanWaveModel.H @@ -0,0 +1,157 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2017 OpenCFD Ltd. + \\/ M anipulation | Copyright (C) 2017 IH-Cantabria +------------------------------------------------------------------------------- +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 <http://www.gnu.org/licenses/>. + +Class + Foam::waveModels::McCowan + +Description + McCowan wave model + +\*---------------------------------------------------------------------------*/ + +#ifndef waveModels_McCowan_H +#define waveModels_McCowan_H + +#include "solitaryWaveModel.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ +namespace waveModels +{ + +/*---------------------------------------------------------------------------*\ + Class McCowan Declaration +\*---------------------------------------------------------------------------*/ + +class McCowan +: + public solitaryWaveModel +{ +protected: + + // Protected Member Functions + + //- Wave height + virtual scalar eta + ( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0 + ) const; + + virtual vector mn + ( + const scalar H, + const scalar h + ) const; + + virtual scalar newtonRapsonF1 + ( + const scalar x0, + const scalar H, + const scalar h + ) const; + + virtual scalar newtonRapsonF2 + ( + const scalar x0, + const scalar H, + const scalar h, + const scalar xa, + const scalar m, + const scalar n + ) const; + + //- Wave velocity + virtual vector Uf + ( + const scalar H, + const scalar h, + const scalar x, + const scalar y, + const scalar theta, + const scalar t, + const scalar X0, + const scalar z + ) const; + + //- Set the water level + virtual void setLevel + ( + const scalar t, + const scalar tCoeff, + scalarField& level + ) const; + + //- Calculate the wave model velocity + virtual void setVelocity + ( + const scalar t, + const scalar tCoeff, + const scalarField& level + ); + + +public: + + //- Runtime type information + TypeName("McCowan"); + + //- Constructor + McCowan + ( + const dictionary& dict, + const fvMesh& mesh, + const polyPatch& patch, + const bool readFields = true + ); + + //- Destructor + virtual ~McCowan(); + + + // Public Member Functions + + //- Read from dictionary + virtual bool readDict(const dictionary& overrideDict); + + //- Info + virtual void info(Ostream& os) const; +}; + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace waveModels +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/alpha.water b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/alpha.water index 424d47590253066912d94924a60135b00aca8dd3..959065167c498fd8cc9495488ea851dac5be5f09 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/alpha.water +++ b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/alpha.water @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/p_rgh b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/p_rgh index fc70fdea5388de40aa038c8ec4a8f72cee473d1d..f43a02558ad327182dcc2f80277b809499671245 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/p_rgh +++ b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/0.orig/p_rgh @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/transportProperties b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/transportProperties index be4da001c23c1eca08963fe61914a2c5ae513aaa..43a98e9c59e2bd89ed7261daa5bc888e41b96155 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/transportProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/transportProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/waveProperties b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/waveProperties index 34a5dbc9da2cc0856f2f0548864f964dc2e4c835..d2b92d8eceb30f92e4779219b2b70d0916006e87 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/waveProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleCnoidal/constant/waveProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.openfoam.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/alpha.water b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/alpha.water index 424d47590253066912d94924a60135b00aca8dd3..959065167c498fd8cc9495488ea851dac5be5f09 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/alpha.water +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/alpha.water @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/p_rgh b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/p_rgh index fc70fdea5388de40aa038c8ec4a8f72cee473d1d..f43a02558ad327182dcc2f80277b809499671245 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/p_rgh +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/0.orig/p_rgh @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/transportProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/transportProperties index be4da001c23c1eca08963fe61914a2c5ae513aaa..43a98e9c59e2bd89ed7261daa5bc888e41b96155 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/transportProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/transportProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/waveProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/waveProperties index b2568d8bda9376e8d121bdf42c2a2533f2a98ea9..88386246c7c90d5c6c5c33667483c61b8bff2ee1 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/waveProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitary/constant/waveProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.openfoam.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/U b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/U new file mode 100644 index 0000000000000000000000000000000000000000..1578cd568211f7034119a38193894c5e76af370f --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/U @@ -0,0 +1,53 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object U; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + left + { + type waveVelocity; + value uniform (0 0 0); + } + + right + { + type waveVelocity; + value uniform (0 0 0); + } + + sides + { + type slip; + } + + ground + { + type noSlip; + } + + top + { + type pressureInletOutletVelocity; + value uniform (0 0 0); + } +} + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/alpha.water b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/alpha.water new file mode 100644 index 0000000000000000000000000000000000000000..0d1342625b1921d044e46cf0688483e8f5874fed --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/alpha.water @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object alpha.water; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + left + { + type waveAlpha; + value uniform 0; + } + + right + { + type zeroGradient; + } + + ground + { + type zeroGradient; + } + + sides + { + type zeroGradient; + } + + top + { + type inletOutlet; + inletValue uniform 0; + value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/p_rgh b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/p_rgh new file mode 100644 index 0000000000000000000000000000000000000000..84d15c7c0a0f318a751e7b41bbbf8fa7d0803c60 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/0.orig/p_rgh @@ -0,0 +1,60 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object p_rgh; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + left + { + type fixedFluxPressure; + value uniform 0; + } + + right + { + type fixedFluxPressure; + value uniform 0; + } + + ground + { + type fixedFluxPressure; + value uniform 0; + } + + sides + { + type slip; + } + + top + { + type totalPressure; + U U; + phi rhoPhi; + rho rho; + psi none; + gamma 1; + p0 uniform 0; + value uniform 0; + } +} + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/Allclean b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/Allclean new file mode 100755 index 0000000000000000000000000000000000000000..705f91474c4a86592eb4f9f16b842144f410492f --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/Allclean @@ -0,0 +1,10 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # run from this directory + +# Source tutorial run functions +. $WM_PROJECT_DIR/bin/tools/CleanFunctions + +rm -rf 0 + +cleanCase + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/Allrun b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/Allrun new file mode 100755 index 0000000000000000000000000000000000000000..9f0c668029a93fea007d22217c227f723d480abe --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/Allrun @@ -0,0 +1,15 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # run from this directory + +# Source tutorial run functions +. $WM_PROJECT_DIR/bin/tools/RunFunctions + +restore0Dir + +runApplication blockMesh + +runApplication decomposePar + +runParallel setFields + +runParallel $(getApplication) diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/g b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/g new file mode 100644 index 0000000000000000000000000000000000000000..195dbea3f3cac083e26f182b8ae44f0074c8486c --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/g @@ -0,0 +1,22 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class uniformDimensionedVectorField; + location "constant"; + object g; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -2 0 0 0 0]; +value ( 0 0 -9.81 ); + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/transportProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/transportProperties new file mode 100644 index 0000000000000000000000000000000000000000..eaf6dbd9193aa663e0280c71f8802c02ca5a1320 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/transportProperties @@ -0,0 +1,37 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +phases (water air); + +water +{ + transportModel Newtonian; + nu [0 2 -1 0 0 0 0] 1e-06; + rho [1 -3 0 0 0 0 0] 1000; +} + +air +{ + transportModel Newtonian; + nu [0 2 -1 0 0 0 0] 1.48e-05; + rho [1 -3 0 0 0 0 0] 1; +} + +sigma [1 0 -2 0 0 0 0] 0.07; + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/turbulenceProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/turbulenceProperties new file mode 100644 index 0000000000000000000000000000000000000000..e4ad75d18c58796a41b783918420c965ae86fd6a --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/turbulenceProperties @@ -0,0 +1,20 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object turbulenceProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +simulationType laminar; + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/waveProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/waveProperties new file mode 100644 index 0000000000000000000000000000000000000000..57ab91a543d7d6eabcc1bea0600f320be74dab01 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/constant/waveProperties @@ -0,0 +1,43 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object wavesProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +left +{ + alpha alpha.water; + + waveModel Grimshaw; + + nPaddle 1; + + waveHeight 0.05; + + waveAngle 0.0; + + activeAbsorption no; +} + +right +{ + alpha alpha.water; + + waveModel shallowWaterAbsorption; + + nPaddle 1; +} + +// ************************************************************************* // + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/blockMeshDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/blockMeshDict new file mode 100644 index 0000000000000000000000000000000000000000..6de6c2f0f23bd8ddab955398ea141fd12410e4ff --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/blockMeshDict @@ -0,0 +1,89 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object blockMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +convertToMeters 1; + +vertices +( + ( 0.0 0.0 0.0) + ( 7.0 0.0 0.0) + ( 7.0 0.55 0.0) + ( 0.0 0.55 0.0) + ( 0.0 0.0 0.5) + ( 7.0 0.0 0.5) + ( 7.0 0.55 0.5) + ( 0.0 0.55 0.5) + +); + +blocks +( + hex (0 1 2 3 4 5 6 7) (350 28 42) simpleGrading (1 1 1) +); +edges +( +); + +boundary +( + left + { + type patch; + faces + ( + (0 4 7 3) + ); + } + right + { + type patch; + faces + ( + (1 5 6 2) + ); + } + ground + { + type wall; + faces + ( + (0 1 2 3) + ); + } + top + { + type patch; + faces + ( + (4 5 6 7) + ); + } + sides + { + type patch; + faces + ( + (0 1 5 4) + (3 2 6 7) + ); + } +); + +mergePatchPairs +( +); + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/controlDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/controlDict new file mode 100644 index 0000000000000000000000000000000000000000..0c2f5298d0c4397f3c23cdb7565f06feec75b62e --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/controlDict @@ -0,0 +1,138 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application interFoam; + +startFrom latestTime; + +startTime 0; + +stopAt endTime; + +endTime 7.0; + +deltaT 0.1; + +writeControl adjustableRunTime; + +writeInterval 0.1; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable yes; + +adjustTimeStep on; + +maxCo 0.4; +maxAlphaCo 0.4; + +maxDeltaT 0.01; + +functions +{ + line + { + type sets; + libs ("libsampling.so"); + enabled true; + writeControl writeTime; + + interpolationScheme cellPoint; + setFormat raw; + sets + ( + s1 + { + type uniform; + axis distance; + start ( 0.865 0.275 0.0 ); + end ( 0.865 0.275 0.5 ); + nPoints 101; + } + + s2 + { + type uniform; + axis distance; + start ( 1.065 0.275 0.0 ); + end ( 1.065 0.275 0.5 ); + nPoints 101; + } + + s3 + { + type uniform; + axis distance; + start ( 4.1 0.275 0.0 ); + end ( 4.1 0.275 0.5 ); + nPoints 101; + } + + s4 + { + type uniform; + axis distance; + start ( 4.645 0.275 0.0 ); + end ( 4.645 0.275 0.5 ); + nPoints 101; + } + + s5 + { + type uniform; + axis distance; + start ( 5.2 0.275 0.0 ); + end ( 5.2 0.275 0.5 ); + nPoints 101; + } + + s6 + { + type uniform; + axis distance; + start ( 5.85 0.275 0.0 ); + end ( 5.85 0.275 0.5 ); + nPoints 101; + } + + s7 + { + type uniform; + axis distance; + start ( 6.15 0.275 0.0 ); + end ( 6.15 0.275 0.5 ); + nPoints 101; + } + ); + + fixedLocations false; + fields (alpha.water); + } +} + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/decomposeParDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/decomposeParDict new file mode 100644 index 0000000000000000000000000000000000000000..301d97027b8aa1815be46c6525b8a54c5f6b6de1 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/decomposeParDict @@ -0,0 +1,29 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object decomposeParDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +numberOfSubdomains 2; + +method hierarchical; + +hierarchicalCoeffs +{ + n (2 1 1); + delta 0.001; + order xyz; +} + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/fvSchemes b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/fvSchemes new file mode 100644 index 0000000000000000000000000000000000000000..eeff89271fbc31a2b0adeb80ad6afdef35eba94e --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/fvSchemes @@ -0,0 +1,54 @@ + +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; +} + +divSchemes +{ + div(rhoPhi,U) Gauss linearUpwind grad(U); + div(phi,alpha) Gauss vanLeer; + div(phirb,alpha) Gauss linear; + div(((rho*nuEff)*dev2(T(grad(U))))) Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear orthogonal; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default orthogonal; +} + + +// ************************************************************************* // + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/fvSolution b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/fvSolution new file mode 100644 index 0000000000000000000000000000000000000000..dee334f852def87e5a1e475dff7ae74349491321 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/fvSolution @@ -0,0 +1,78 @@ + +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "alpha.water.*" + { + nAlphaCorr 1; + nAlphaSubCycles 3; + cAlpha 1; + } + + "pcorr.*" + { + solver PCG; + preconditioner DIC; + tolerance 1e-6; + relTol 0; + } + + p_rgh + { + solver PCG; + preconditioner DIC; + tolerance 1e-6; + relTol 0.1; + } + + p_rghFinal + { + solver GAMG; + smoother DIC; + tolerance 1e-7; + relTol 0; + } + + U + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-6; + relTol 0.1; + } + + UFinal + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-6; + relTol 0; + } +} + +PIMPLE +{ + momentumPredictor no; + nCorrectors 2; + nNonOrthogonalCorrectors 0; +} + + +// ************************************************************************* // + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/setFieldsDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/setFieldsDict new file mode 100644 index 0000000000000000000000000000000000000000..b3c7c3af19553f75725d06e027079a9855a91576 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryGrimshaw/system/setFieldsDict @@ -0,0 +1,37 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object setFieldsDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +defaultFieldValues +( + volScalarFieldValue alpha.water 0 + volVectorFieldValue U (0 0 0) +); + +regions +( + boxToCell + { + box (-10 -10 -10) (100 100 0.15); + fieldValues + ( + volScalarFieldValue alpha.water 1 + ); + } +); + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/U b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/U new file mode 100644 index 0000000000000000000000000000000000000000..1578cd568211f7034119a38193894c5e76af370f --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/U @@ -0,0 +1,53 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volVectorField; + location "0"; + object U; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -1 0 0 0 0]; + +internalField uniform (0 0 0); + +boundaryField +{ + left + { + type waveVelocity; + value uniform (0 0 0); + } + + right + { + type waveVelocity; + value uniform (0 0 0); + } + + sides + { + type slip; + } + + ground + { + type noSlip; + } + + top + { + type pressureInletOutletVelocity; + value uniform (0 0 0); + } +} + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/alpha.water b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/alpha.water new file mode 100644 index 0000000000000000000000000000000000000000..0d1342625b1921d044e46cf0688483e8f5874fed --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/alpha.water @@ -0,0 +1,52 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object alpha.water; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 0 0 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + left + { + type waveAlpha; + value uniform 0; + } + + right + { + type zeroGradient; + } + + ground + { + type zeroGradient; + } + + sides + { + type zeroGradient; + } + + top + { + type inletOutlet; + inletValue uniform 0; + value uniform 0; + } +} + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/p_rgh b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/p_rgh new file mode 100644 index 0000000000000000000000000000000000000000..84d15c7c0a0f318a751e7b41bbbf8fa7d0803c60 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/0.orig/p_rgh @@ -0,0 +1,60 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class volScalarField; + object p_rgh; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [1 -1 -2 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + left + { + type fixedFluxPressure; + value uniform 0; + } + + right + { + type fixedFluxPressure; + value uniform 0; + } + + ground + { + type fixedFluxPressure; + value uniform 0; + } + + sides + { + type slip; + } + + top + { + type totalPressure; + U U; + phi rhoPhi; + rho rho; + psi none; + gamma 1; + p0 uniform 0; + value uniform 0; + } +} + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/Allclean b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/Allclean new file mode 100755 index 0000000000000000000000000000000000000000..705f91474c4a86592eb4f9f16b842144f410492f --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/Allclean @@ -0,0 +1,10 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # run from this directory + +# Source tutorial run functions +. $WM_PROJECT_DIR/bin/tools/CleanFunctions + +rm -rf 0 + +cleanCase + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/Allrun b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/Allrun new file mode 100755 index 0000000000000000000000000000000000000000..9f0c668029a93fea007d22217c227f723d480abe --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/Allrun @@ -0,0 +1,15 @@ +#!/bin/sh +cd ${0%/*} || exit 1 # run from this directory + +# Source tutorial run functions +. $WM_PROJECT_DIR/bin/tools/RunFunctions + +restore0Dir + +runApplication blockMesh + +runApplication decomposePar + +runParallel setFields + +runParallel $(getApplication) diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/g b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/g new file mode 100644 index 0000000000000000000000000000000000000000..195dbea3f3cac083e26f182b8ae44f0074c8486c --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/g @@ -0,0 +1,22 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class uniformDimensionedVectorField; + location "constant"; + object g; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 1 -2 0 0 0 0]; +value ( 0 0 -9.81 ); + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/transportProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/transportProperties new file mode 100644 index 0000000000000000000000000000000000000000..eaf6dbd9193aa663e0280c71f8802c02ca5a1320 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/transportProperties @@ -0,0 +1,37 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object transportProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +phases (water air); + +water +{ + transportModel Newtonian; + nu [0 2 -1 0 0 0 0] 1e-06; + rho [1 -3 0 0 0 0 0] 1000; +} + +air +{ + transportModel Newtonian; + nu [0 2 -1 0 0 0 0] 1.48e-05; + rho [1 -3 0 0 0 0 0] 1; +} + +sigma [1 0 -2 0 0 0 0] 0.07; + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/turbulenceProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/turbulenceProperties new file mode 100644 index 0000000000000000000000000000000000000000..e4ad75d18c58796a41b783918420c965ae86fd6a --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/turbulenceProperties @@ -0,0 +1,20 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object turbulenceProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +simulationType laminar; + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/waveProperties b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/waveProperties new file mode 100644 index 0000000000000000000000000000000000000000..55497bf88ec8d38a2f181573aac0d4b64892ac3b --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/constant/waveProperties @@ -0,0 +1,43 @@ +/*---------------------------------------------------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "constant"; + object wavesProperties; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +left +{ + alpha alpha.water; + + waveModel McCowan; + + nPaddle 1; + + waveHeight 0.05; + + waveAngle 0.0; + + activeAbsorption yes; +} + +right +{ + alpha alpha.water; + + waveModel shallowWaterAbsorption; + + nPaddle 1; +} + +// ************************************************************************* // + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/blockMeshDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/blockMeshDict new file mode 100644 index 0000000000000000000000000000000000000000..6de6c2f0f23bd8ddab955398ea141fd12410e4ff --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/blockMeshDict @@ -0,0 +1,89 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object blockMeshDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +convertToMeters 1; + +vertices +( + ( 0.0 0.0 0.0) + ( 7.0 0.0 0.0) + ( 7.0 0.55 0.0) + ( 0.0 0.55 0.0) + ( 0.0 0.0 0.5) + ( 7.0 0.0 0.5) + ( 7.0 0.55 0.5) + ( 0.0 0.55 0.5) + +); + +blocks +( + hex (0 1 2 3 4 5 6 7) (350 28 42) simpleGrading (1 1 1) +); +edges +( +); + +boundary +( + left + { + type patch; + faces + ( + (0 4 7 3) + ); + } + right + { + type patch; + faces + ( + (1 5 6 2) + ); + } + ground + { + type wall; + faces + ( + (0 1 2 3) + ); + } + top + { + type patch; + faces + ( + (4 5 6 7) + ); + } + sides + { + type patch; + faces + ( + (0 1 5 4) + (3 2 6 7) + ); + } +); + +mergePatchPairs +( +); + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/controlDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/controlDict new file mode 100644 index 0000000000000000000000000000000000000000..0c2f5298d0c4397f3c23cdb7565f06feec75b62e --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/controlDict @@ -0,0 +1,138 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object controlDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +application interFoam; + +startFrom latestTime; + +startTime 0; + +stopAt endTime; + +endTime 7.0; + +deltaT 0.1; + +writeControl adjustableRunTime; + +writeInterval 0.1; + +purgeWrite 0; + +writeFormat ascii; + +writePrecision 6; + +writeCompression uncompressed; + +timeFormat general; + +timePrecision 6; + +runTimeModifiable yes; + +adjustTimeStep on; + +maxCo 0.4; +maxAlphaCo 0.4; + +maxDeltaT 0.01; + +functions +{ + line + { + type sets; + libs ("libsampling.so"); + enabled true; + writeControl writeTime; + + interpolationScheme cellPoint; + setFormat raw; + sets + ( + s1 + { + type uniform; + axis distance; + start ( 0.865 0.275 0.0 ); + end ( 0.865 0.275 0.5 ); + nPoints 101; + } + + s2 + { + type uniform; + axis distance; + start ( 1.065 0.275 0.0 ); + end ( 1.065 0.275 0.5 ); + nPoints 101; + } + + s3 + { + type uniform; + axis distance; + start ( 4.1 0.275 0.0 ); + end ( 4.1 0.275 0.5 ); + nPoints 101; + } + + s4 + { + type uniform; + axis distance; + start ( 4.645 0.275 0.0 ); + end ( 4.645 0.275 0.5 ); + nPoints 101; + } + + s5 + { + type uniform; + axis distance; + start ( 5.2 0.275 0.0 ); + end ( 5.2 0.275 0.5 ); + nPoints 101; + } + + s6 + { + type uniform; + axis distance; + start ( 5.85 0.275 0.0 ); + end ( 5.85 0.275 0.5 ); + nPoints 101; + } + + s7 + { + type uniform; + axis distance; + start ( 6.15 0.275 0.0 ); + end ( 6.15 0.275 0.5 ); + nPoints 101; + } + ); + + fixedLocations false; + fields (alpha.water); + } +} + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/decomposeParDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/decomposeParDict new file mode 100644 index 0000000000000000000000000000000000000000..301d97027b8aa1815be46c6525b8a54c5f6b6de1 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/decomposeParDict @@ -0,0 +1,29 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + object decomposeParDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +numberOfSubdomains 2; + +method hierarchical; + +hierarchicalCoeffs +{ + n (2 1 1); + delta 0.001; + order xyz; +} + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/fvSchemes b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/fvSchemes new file mode 100644 index 0000000000000000000000000000000000000000..eeff89271fbc31a2b0adeb80ad6afdef35eba94e --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/fvSchemes @@ -0,0 +1,54 @@ + +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSchemes; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +ddtSchemes +{ + default Euler; +} + +gradSchemes +{ + default Gauss linear; +} + +divSchemes +{ + div(rhoPhi,U) Gauss linearUpwind grad(U); + div(phi,alpha) Gauss vanLeer; + div(phirb,alpha) Gauss linear; + div(((rho*nuEff)*dev2(T(grad(U))))) Gauss linear; +} + +laplacianSchemes +{ + default Gauss linear orthogonal; +} + +interpolationSchemes +{ + default linear; +} + +snGradSchemes +{ + default orthogonal; +} + + +// ************************************************************************* // + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/fvSolution b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/fvSolution new file mode 100644 index 0000000000000000000000000000000000000000..dee334f852def87e5a1e475dff7ae74349491321 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/fvSolution @@ -0,0 +1,78 @@ + +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object fvSolution; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +solvers +{ + "alpha.water.*" + { + nAlphaCorr 1; + nAlphaSubCycles 3; + cAlpha 1; + } + + "pcorr.*" + { + solver PCG; + preconditioner DIC; + tolerance 1e-6; + relTol 0; + } + + p_rgh + { + solver PCG; + preconditioner DIC; + tolerance 1e-6; + relTol 0.1; + } + + p_rghFinal + { + solver GAMG; + smoother DIC; + tolerance 1e-7; + relTol 0; + } + + U + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-6; + relTol 0.1; + } + + UFinal + { + solver PBiCG; + preconditioner DILU; + tolerance 1e-6; + relTol 0; + } +} + +PIMPLE +{ + momentumPredictor no; + nCorrectors 2; + nNonOrthogonalCorrectors 0; +} + + +// ************************************************************************* // + diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/setFieldsDict b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/setFieldsDict new file mode 100644 index 0000000000000000000000000000000000000000..b3c7c3af19553f75725d06e027079a9855a91576 --- /dev/null +++ b/tutorials/multiphase/interFoam/laminar/waveExampleSolitaryMcCowan/system/setFieldsDict @@ -0,0 +1,37 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: plus | +| \\ / A nd | Web: www.OpenFOAM.com | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ +FoamFile +{ + version 2.0; + format ascii; + class dictionary; + location "system"; + object setFieldsDict; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +defaultFieldValues +( + volScalarFieldValue alpha.water 0 + volVectorFieldValue U (0 0 0) +); + +regions +( + boxToCell + { + box (-10 -10 -10) (100 100 0.15); + fieldValues + ( + volScalarFieldValue alpha.water 1 + ); + } +); + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/alpha.water b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/alpha.water index 424d47590253066912d94924a60135b00aca8dd3..959065167c498fd8cc9495488ea851dac5be5f09 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/alpha.water +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/alpha.water @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/p_rgh b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/p_rgh index fc70fdea5388de40aa038c8ec4a8f72cee473d1d..f43a02558ad327182dcc2f80277b809499671245 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/p_rgh +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/0.orig/p_rgh @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/transportProperties b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/transportProperties index be4da001c23c1eca08963fe61914a2c5ae513aaa..43a98e9c59e2bd89ed7261daa5bc888e41b96155 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/transportProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/transportProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/waveProperties b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/waveProperties index 7597533efdb1be3fbf1712730420abb37e8cdd4f..f96dfbeb590ada941c60193925f6552eb7f6c061 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/waveProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesI/constant/waveProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.openfoam.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/alpha.water b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/alpha.water index 424d47590253066912d94924a60135b00aca8dd3..959065167c498fd8cc9495488ea851dac5be5f09 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/alpha.water +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/alpha.water @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/p_rgh b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/p_rgh index fc70fdea5388de40aa038c8ec4a8f72cee473d1d..f43a02558ad327182dcc2f80277b809499671245 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/p_rgh +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/0.orig/p_rgh @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/transportProperties b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/transportProperties index be4da001c23c1eca08963fe61914a2c5ae513aaa..43a98e9c59e2bd89ed7261daa5bc888e41b96155 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/transportProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/transportProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/waveProperties b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/waveProperties index 2099df6ed53067e8b362594551517982c4011305..bae079fe05b68de9a3e93ddfa6541e032b223219 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/waveProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesII/constant/waveProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.openfoam.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/alpha.water b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/alpha.water index 9069a26b66bfac5a51c2af8e3001ac0b63c831d0..9a3f3f9d014c2d7664b70c9d071b44c1bfe2f552 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/alpha.water +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/alpha.water @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/p_rgh b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/p_rgh index fc70fdea5388de40aa038c8ec4a8f72cee473d1d..f43a02558ad327182dcc2f80277b809499671245 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/p_rgh +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/0.orig/p_rgh @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/transportProperties b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/transportProperties index be4da001c23c1eca08963fe61914a2c5ae513aaa..43a98e9c59e2bd89ed7261daa5bc888e41b96155 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/transportProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/transportProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.OpenFOAM.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/waveProperties b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/waveProperties index 9192fe116177fd6eccf05dcc12d0a313455ac1aa..9ea83ba45733dc03d073a0a7373c2a2168afb63a 100644 --- a/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/waveProperties +++ b/tutorials/multiphase/interFoam/laminar/waveExampleStokesV/constant/waveProperties @@ -2,7 +2,7 @@ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / O peration | Version: plus | -| \\ / A nd | Web: http://www.openfoam.com | +| \\ / A nd | Web: www.OpenFOAM.com | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile