Commit Graph

5902 Commits

Author SHA1 Message Date
03211cda95 Merge branch 'master' of github.com-OpenFOAM:OpenFOAM/OpenFOAM-dev 2022-05-11 21:28:42 +01:00
48d9c77085 Updated documentation for foamInfo: The "Note" entry is now part of "Description" or "Usage"
so that it is printed by foamInfo.
2022-05-11 21:27:27 +01:00
0999cd0efe multiphaseEulerFoam: Added pipeBend tutorial
This tutorial simulates solid particle coalescence and breakage through
a 90 degree pipe bend.

Patch contributed by Kasper Gram Bilde and Institute of Fluid Dynamics,
Helmholtz-Zentrum Dresden - Rossendorf (HZDR)
2022-05-11 15:30:11 +01:00
7a8f59e2b9 Merge branch 'master' of github.com-OpenFOAM:OpenFOAM/OpenFOAM-dev 2022-05-10 16:05:42 +01:00
a346040bcb MomentumTransportModels::ReynoldsStress: Improved the R-U coupling stabilisation algorithm
On unstructured collocated meshes the Reynolds stress tends to decouple from the
velocity creating pronounced staggering patterns in the solution.  This effect
is reduced or eliminated by a special coupling algorithm which replaces the
gradient diffusion component of the Reynolds stress with the equivalent compact
representation on the mesh, i.e. div-grad with Laplacian in the DivDevRhoReff function:

template<class BasicMomentumTransportModel>
template<class RhoFieldType>
Foam::tmp<Foam::fvVectorMatrix>
Foam::ReynoldsStress<BasicMomentumTransportModel>::DivDevRhoReff
(
    const RhoFieldType& rho,
    volVectorField& U
) const
{
    tmp<volTensorField> tgradU = fvc::grad(U);
    const volTensorField& gradU = tgradU();
    const surfaceTensorField gradUf(fvc::interpolate(gradU));

    // Interpolate Reynolds stress to the faces
    // with either a stress or velocity coupling correction
    const surfaceVectorField Refff
    (
        (this->mesh().Sf() & fvc::interpolate(R_))

        // Stress coupling
      + couplingFactor_
       *(this->mesh().Sf() & fvc::interpolate(this->nut()*gradU))

        // or velocity gradient coupling
   // + couplingFactor_
   //  *fvc::interpolate(this->nut())*(this->mesh().Sf() & gradUf)

      - fvc::interpolate(couplingFactor_*this->nut() + this->nu())
       *this->mesh().magSf()*fvc::snGrad(U)
      - fvc::interpolate(this->nu())*(this->mesh().Sf() & dev2(gradUf.T()))
    );

    return
    (
        fvc::div(fvc::interpolate(this->alpha_*rho)*Refff)
      - correction(fvm::laplacian(this->alpha_*rho*this->nuEff(), U))
    );
}

In the above two options for the coupling term are provided, one based on the
stress correction (un-commented) and an alternative based an the velocity
gradient correction (commented).  Tests run so far indicate that the stress
correction provides better coupling while minimising the error introduced.

A new tutorial case ductSecondaryFlow is provided which demonstrates the updated
coupling algorithm on the simulation of the classic secondary flow generated in
rectangular ducts.
2022-05-10 15:54:03 +01:00
1bf620e963 <solver> -postProcess: Support changing meshes 2022-05-10 10:12:59 +01:00
774ff647b0 transformPoints: Added option to restrict transformation to a point set
Transformation can now be restricted to a specific point set by means of
a new -pointSet option. For example, to move the rotating part of a
geometry through 45 degrees around the Z axis, the following command
could be used:

    transformPoints -pointSet rotating "Rz=45"

This assumes a point set called "rotating" has been defined during
meshing or by calling topoSet.
2022-05-07 15:21:16 +01:00
d0ccea2196 generalisedNewtonianViscosityModels: Updated and simplified reading of coefficients 2022-05-06 17:19:39 +01:00
a3f61193a8 fvMeshMoversLayeredEngine: Allow mesh-to-mesh mapping at run-time 2022-05-06 15:56:27 +01:00
55533d2872 tutorials/multiphase/interFoam: Removed unused rhoInf entries from forces functionObject spec 2022-05-06 10:13:54 +01:00
04c54ad541 fvMeshDistribute: Removed topology changes to meshObjects
The topology changes occur in the intermediate steps during mesh sub-division
and addition, there is no need to update meshObjects during this phase, these
are updated at the end of the redistribution by the distribute function called
for each.  The distribute functions for nearWallDist and wallDist have been
updated accordingly.
2022-05-05 13:23:15 +01:00
fc74899204 domainDecomposition: Bug fix to prevent unnecessary mesh copies 2022-05-04 22:21:32 +01:00
7fa89fb6a2 ddtSchemes, fvcMeshPhi: Added patch meshPhi function
to simplify and improve the efficiency of moving wall boundary conditions and
for future use in handling absolute and relative fluxes on patches.
2022-05-04 17:15:49 +01:00
7e84102215 MRF: Added support for moving mesh cases including MRF regions
Now stationary MRF regions may be embedded in moving mesh cases.  While in
principle MRF regions moving with the mesh is supported by this development
there is no special handling with the MRF implementation to support the required
specification of the motion of the MRF regions.
2022-05-04 11:34:45 +01:00
01d82d1e51 rhoPimpleFoam, XiFoam: Updated pEqn to support the fixedFluxExtrapolatedPressure BC 2022-05-03 22:39:44 +01:00
38262243cc flowRateInletVelocity: Map wall distance on decompose, rather than recompute
A wall distance computation will not be correct on a disconnected
processor case. This is also more efficient.

Resolves bug report https://bugs.openfoam.org/view.php?id=3833
2022-05-03 12:25:23 +01:00
00777cffa4 fvPatchDistWave: Generate FV mesh geometry before the wave
This prevents hangs from occurring when a single processor accesses the
cell or face centres
2022-05-03 10:35:47 +01:00
376b51b58b multiphaseEulerFoam::populationBalanceModel: improved dilatation treatment
The population balance model considers dilatation originating from density
change and mass transfer via source terms describing nucleation as well as
"drift" of the size distribution to smaller or larger sizes. Numerically, the
treatment does not necessarily equal the total dilatation, hence a correction is
introduced to ensure boundedness of the size group fractions.

Patch contributed by Institute of Fluid Dynamics,
Helmholtz-Zentrum Dresden - Rossendorf (HZDR)
and VTT Technical Research Centre of Finland Ltd.
2022-04-29 16:18:03 +01:00
58444464aa initialConditions: Corrected header
Resolves bug-report https://bugs.openfoam.org/view.php?id=3831
2022-04-29 12:29:05 +01:00
3ef1a3287e applications/solvers/multiphase::pEqn: Check for rAU validity before resetting
Avoids problems when the mesh is not changing but correctPhi is set true.
2022-04-27 14:56:14 +01:00
54de79b573 fvMeshTopoChangersRefiner: Avoid writing the pointLevel and cellLevel files if the mesh has not changed 2022-04-27 14:55:34 +01:00
95b6b0c003 tutorials: Renamed 2D MRF mixer vessel cases to mixerVessel2DMRF 2022-04-27 12:31:09 +01:00
2beec217d9 tutorials: interFoam: mixerVessel2D: Fix typo 2022-04-27 12:17:21 +01:00
3a2f1b7dd7 Merge branch 'master' of github.com-OpenFOAM:OpenFOAM/OpenFOAM-dev 2022-04-27 12:10:56 +01:00
dd8e1fb5e0 LaheyKEpsilon: coefficient C3 -> C4 to avoid name clash with C3 in the base kEpsilon 2022-04-27 12:09:20 +01:00
b92fdc82f5 tutorials: pipeCyclic: Overhaul
The refinement cell set is now generated directly using boxToCell. The
mesh now uses cyclic, rather than cyclicAMI, patches so that propagation
of the refinement across the coupling can be tested. Field files have
been simplified by using #includeEtc to set constraints. A best practice
velocity/pressure specification has been set for the outlet boundary.
Unused fields and settings have been removed.
2022-04-27 11:54:41 +01:00
7b3631bc53 surfaceInterpolation::phaseStabilised, phaseStabilisedSnGrad: phase-fraction stabilised schemes
New interpolation and snGrad schemes to help stabilise multiphaseEulerFoam runs
on poor meshes by reverting to a bounded form when the phase-fraction
corresponding to the phase of the field argument is less than 1e-3.  If this
approach proves effective and it would be useful to adjust the phase-fraction
limit it could be made a user input.

Class
    Foam::phaseStabilised

Description
    Phase-stabilised interpolation scheme

    which applies upwind to the faces at which the upwind phase-fraction is less
    than 1e-3.

Class
    Foam::fv::phaseStabilisedSnGrad

Description
    snGrad scheme with phase-fraction limited non-orthogonal correction.

    When the phase-fraction is less than 1e-3 the non-orthogonal correction is
    set to 0.

Example specification in fvSchemes:

gradSchemes
{
    default         Gauss linear;
    limited         cellLimited Gauss linear 1;
}

divSchemes
{
    default                         none;

    .
    .
    .

    "div\(alphaRhoPhi.*,U.*\)"      Gauss phaseStabilised linearUpwindV limited;
    "div\(phi.*,U.*\)"              Gauss phaseStabilised linearUpwindV limited;

    "div\(alphaRhoPhi.*,(h|e).*\)"  Gauss phaseStabilised limitedLinear 1;
    "div\(alphaRhoPhi.*,K.*\)"      Gauss phaseStabilised limitedLinear 1;
    "div\(alphaRhoPhi.*,\(p\|thermo:rho.*\)\)" Gauss phaseStabilised limitedLinear 1;

    .
    .
    .
}

laplacianSchemes
{
    default         Gauss linear limited corrected 0.33;

    phaseStabilised Gauss linear phaseStabilised limited corrected 0.33;

    laplacian(((alpha.air*thermo:rho.air)*nuEff.air),U.air) $phaseStabilised;
    laplacian(((alpha.water*thermo:rho.water)*nuEff.water),U.water) $phaseStabilised;

    laplacian((alpha.air*alphaEff),h.air) $phaseStabilised;
    laplacian((alpha.water*alphaEff),e.water) $phaseStabilised;
}
2022-04-27 11:03:01 +01:00
24066e1f90 Merge branch 'master' of github.com-OpenFOAM:OpenFOAM/OpenFOAM-dev 2022-04-27 10:29:49 +01:00
4aab8572a4 momentumTransportModels::RAS: Corrected documentation of C3 coefficient
Resolves bug-report https://bugs.openfoam.org/view.php?id=3830
2022-04-27 10:28:37 +01:00
8aecadcafd particleTracks: Made compatible with dynamicMesh and updated annotated dictionary 2022-04-26 17:19:56 +01:00
14a9515aa0 surfaceInterpolation: Updated and rationalised documentation: differencing -> interpolation 2022-04-26 14:43:54 +01:00
2cf6090203 driftFluxFoam::relativeVelocityModels::MichaelsBolger: alphaMax in now obtain from phaseProperties 2022-04-22 16:54:01 +01:00
64a2a3bf75 driftFluxFoam::relativeVelocityModels: Added MichaelsBolger model for flocculated suspensions
Description
    Michaels & Bolger relative velocity model

    Reference:
    \verbatim
        Michaels, A. S., & Bolger, J. C. (1962).
        Settling rates and sediment volumes
        of flocculated kaolin suspensions.
        Industrial & Engineering Chemistry Fundamentals, 1(1), 24-33.
    \endverbatim

Usage
    Example usage:
    \verbatim
        relativeVelocityModel MichaelsBolger;

        MichaelsBolgerCoeffs
        {
            a0          0;    // Extended Michaels & Bolger coefficient,
            a1          4.65; // Exponent

            alphaMax    0.6;  // Maximum dispersed phase-fraction
                              // (packing fraction)
        }
    \endverbatim
2022-04-22 16:50:41 +01:00
929c69340f PrimitivePatch: Removed virtualisation and unused constructors
PrimitivePatch is a geometry engine. Is not used, and is not designed to
be used, as an abstract interface. That function is left to
PrimitivePatch's immediate derivations, such as polyPatch and
MeshedSurface.
2022-04-22 12:10:01 +01:00
681e58bbda surfaceInterpolation: simplified headers of schemes 2022-04-21 15:51:09 +01:00
18cd22fe5d volFieldValue: Corrected min and max operation for scalars
Resolves bug report https://bugs.openfoam.org/view.php?id=3828
2022-04-21 15:16:31 +01:00
d5820be68b layerAverage: Re-write layer generation using mesh wave
This change means this function is determining the sequence in which
points are plotted topologically. This makes it possible to plot a layer
average along a pipe that goes through many changes of direction.

Previously, the function determined the order by means of a geometric
sort in the plot direction. This only worked when the layers were
perpendicular to one of the coordinate axes.
2022-04-21 13:27:22 +01:00
d67aecf0cb functionObjects: New function to reconstruct cell velocity from face flux
This is a simple function that provides a convenient way for a user to
call fvc::reconstruct for the purposes of post-processing flux fields;
e.g., to construct a cell velocity from a face flux.

It can be used to generate output during a run by adding the following
settings to a case's controlDict:

    functions
    {
        #includeFunc reconstruct(phi)
    }

Or it can be executed as a postProcessing step by calling:

    postProcess -func "reconstruct(phi)"
2022-04-21 09:27:01 +01:00
ff1a3fdd9d surfaceInterpolation::surfaceInterpolation: Simplified implementation 2022-04-21 09:02:06 +01:00
c444fd4538 MomentumTransportModels: Removed temporary diagnostic messages 2022-04-21 09:01:15 +01:00
3bac211785 epsilonmWallFunction: New wall-function specifically for the mixtureKEpsilon model
epsilonm is obtained by combining epsilon.gas and epsilon.liquid in a two-phase
system, each of which will apply the epsilonWallFunction at walls; the
epsilonmWallFunction propagates the resulting wall epsilonm into the near-wall
cells.

If the 0/epsilonm file is provided the epsilonmWallFunction should be specified
for walls, if the 0/epsilonm file is not provided it will be generated
automatically and the epsilonmWallFunction applied to walls for which the
epsilonWallFunction is specified in the epsilon.liquid file.
2022-04-20 18:48:35 +01:00
a4a03db574 DiagTensor: Added SymmTensor combination operations 2022-04-14 09:25:07 +01:00
620cbe9d1f driftFluxFoam: Generalised the treatment of the effect of flow curvature
Rather than rely on the MRF rotation the effect of acceleration due to flow
curvature on the dispersed is now handled directly using the Ud.grad(Ud) term
derived from the phase momentum equation.  This means that any flow curvature
from bulk rotation to recirulation zones now affect the separation of the
dispersed phase from the continuous phase in a physical manner.
2022-04-13 11:24:56 +01:00
5e99344348 multiphaseEulerFoam::populationBalanceModel: Removed temporary dilatation correction
and updated tutorials to work with the current phase limit stabilisation.
2022-04-12 10:23:42 +01:00
043b06f129 adjustPhi: Include cyclic patches when calculating the total flux through the domain
to handle cyclic cases where a body-force is used to drive the mean flow.
2022-04-12 10:19:46 +01:00
48e2ff1fec cavitatingFoam: Corrected correctUf call to use the absolute flux
Resolves bug-report https://bugs.openfoam.org/view.php?id=3825
2022-04-11 16:08:05 +01:00
9297b3c679 regIOobject: Added a move constructor
to resolve an issue with the unexpected registration of DimensionedFields
constructed from an unregistered temporary field.
2022-04-08 18:57:37 +01:00
b8ce733e4b fvMesh: Separated fvMesh::move() and fvMesh::update()
fvMesh::update() now executes at the beginning of the time-step, before time is
incremented and handles topology change, mesh to mesh mapping and redistribution
without point motion.  Following each of these mesh changes fields are mapped
from the previous mesh state to new mesh state in a conservative manner.  These
mesh changes not occur at most once per time-step.

fvMesh::move() is executed after time is incremented and handles point motion
mesh morphing during the time-step in an Arbitrary Lagrangian Eulerian approach
requiring the mesh motion flux to match the cell volume change.  fvMesh::move()
can be called any number of times during the time-step to allow iterative update
of the coupling between the mesh motion and field solution.
2022-04-08 18:46:12 +01:00
d867d35a82 phaseCompressibleMomentumTransportModels: Added RNGkEpsilon 2022-04-08 09:23:48 +01:00
47b0cd54dd fvMeshTopoChangers::meshToMesh: New fvMesh topoChanger which maps to a sequence of meshes at run-time
With fvMeshTopoChangers::meshToMesh it is now possible to map the solution to a
specified sequence of pre-generated meshes at run-time to support arbitrary mesh
changes, refinements, un-refinements, changes in region topology, geometry,
etc.  Additionally mesh-motion between the sequence of meshes is supported to
allow for e.g. piston and valve motion in engines.

The tutorials/incompressible/pimpleFoam/laminar/movingCone case has been updated
to provide a demonstration of the advantages of this run-time mesh-mapping by
mapping to meshes that are finer behind the cone and coarser in front of the
cone as the cone approaches the end of the domain, thus maintaining good
resolution while avoiding excessive cell aspect ratio as the mesh is squeezed.
The dynamicMeshDict for the movingCone case is;

mover
{
    type            motionSolver;

    libs            ("libfvMeshMovers.so" "libfvMotionSolvers.so");

    motionSolver    velocityComponentLaplacian;

    component       x;
    diffusivity     directional (1 200 0);
}

topoChanger
{
    type    meshToMesh;

    libs    ("libmeshToMeshTopoChanger.so");

    times   (0.0015 0.003);

    timeDelta 1e-6;
}

which lists the mesh mapping times 0.0015s 0.003s and meshes for these times in
directories constant/meshToMesh_0.0015 and constant/meshToMesh_0.003 are
generated in the Allrun script before the pimpleFoam run:

runApplication -a blockMesh -dict blockMeshDict.2
rm -rf constant/meshToMesh_0.0015
mkdir constant/meshToMesh_0.0015
mv constant/polyMesh constant/meshToMesh_0.0015

runApplication -a blockMesh -dict blockMeshDict.3
rm -rf constant/meshToMesh_0.003
mkdir constant/meshToMesh_0.003
mv constant/polyMesh constant/meshToMesh_0.003

runApplication -a blockMesh -dict blockMeshDict.1

runApplication $application

Note: This functionality is experimental and has only undergone basic testing.
It is likely that it does not yet work with all functionObject, fvModels
etc. which will need updating to support this form of mesh topology change.
2022-04-06 16:37:22 +01:00