Merge commit 'OpenCFD/master' into olesenm

This commit is contained in:
Mark Olesen
2009-07-15 08:20:06 +02:00
191 changed files with 4327 additions and 1545 deletions

View File

@ -1,176 +0,0 @@
# -*- mode: org; -*-
#
#+TITLE: *OpenFOAM release notes for version 1.5*
#+AUTHOR: OpenCFD Ltd.
#+DATE: 07 October 2008
#+LINK: http://www.opencfd.co.uk
#+OPTIONS: author:nil ^:{}
* Overview
OpenFOAM-1.5 is is a significant upgrade to version 1.4 in ways which are
outlined below. This release passes all our standard tests and the tutorials
have been broadly checked. If there are any bugs, please report them using
the instructions set out in: http://www.OpenFOAM.org/bugs.html.
Most of the developments for this release are in: new applications, e.g. for
multiphase flow and cavitation, buoyancy-flow and heat transfer, high speed
flows and even molecular dynamics; new utilities, e.g. for meshing and case
monitoring; and, new modelling, e.g. in Lagrangian particle tracking,
radiation and rotating frames of reference. With these new applications come
numerous new example cases.
* GNU/Linux version
The 64bit binary packs of the OpenFOAM release were compiled on a machine
running SuSE GNU/Linux version 10.3 and the 32bit on a machine running Ubuntu
GNU/Linux version 7.1 and also tested on Ubuntu 8.04. We recommend that
users run OpenFOAM on one of these or a similar recent version of GNU/Linux.
This release has also been successfully compiled and tested on older GNU/Linux
releases but this requires the installation of Qt 4.3.? for ParaView-3 to run.
* C++ Compiler version
+ Released compiled with GCC 4.3.1, the latest version.
+ Built in support for the Intel C++ 10.? compiler (untested).
+ The choice of the compiler is controlled by the setting of the $WM_COMPILER
and $WM_COMPILER_ARCH environment variables in the OpenFOAM-1.5/etc/bashrc
(or cshrc) file.
+ The location of the installation of the compiler is controlled by the
$compilerInstall environment variable in the OpenFOAM-1.5/etc/settings.sh
(or settings.csh) file.
* Developments to solvers (applications)
+ New rhoCentralFoam solver for high-speed, viscous, compressible flows using
non-oscillatory, central-upwind schemes.
+ New interDyMFoam solver for 2 incompressible, isothermal, immiscible fluids
using a VoF phase-fraction based interface capturing approach, with optional
mesh motion and mesh topology changes including adaptive mesh
(un)refinement. Useful for simulations such as tank filling, sloshing ---
using solid body motion e.g. SDA or SKA (6DoF) --- and slamming (using the
mesh motion solver) and other large-scale applications that benefit from the
efficiency gain of adaptive mesh (un)refinement of the interface.
+ New compressibleInterFoam solver for 2 compressible, isothermal, immiscible
fluids using a volume of fluid (VoF) phase-fraction approach for
interface-capturing. The momentum and other fluid properties are of the
"mixture" and a single momentum equation is solved. Turbulence is modelled
using a run-time selectable incompressible LES model.
+ New interPhaseChangeFoam solver for 2 incompressible, isothermal, immiscible
fluids with phase-change, e.g. cavitation. Uses VoF interface capturing,
with momentum and other fluid properties described for the ``mixture'' and a
single momentum equation is solved. The set of phase-change models provided
are designed to simulate cavitation but other mechanisms of phase-change are
supported within this solver framework.
+ New rasCavitatingFoam solver for transient cavitation using a barotropic
compressibility model, with RAS turbulence.
+ New lesCavitatingFoam solver for transient cavitation using a barotropic
compressibility model, with LES turbulence.
+ New chtMultiRegionFoam solver that couples conjugate heat transfer in a
solid to a buoyancy-driven flow simulation.
+ New PDRFoam solver for compressible premixed/partially-premixed turbulent
combustion that includes porosity/distributed resistance (PDR) modelling to
handle regions containing solid blockages which cannot be resolved by the
mesh. Requires the PDR fields.
+ New lesBuoyantFoam solver for transient, buoyant, turbulent flow of
compressible fluids for ventilation and heat-transfer. Turbulence is
modelled using a run-time selectable compressible LES model.
+ New rhoPimpleFoam solver for transient, turbulent flow of compressible
fluids for ventilation and heat-transfer. Uses the flexible PIMPLE
(PISO-SIMPLE) solution for time-resolved and pseudo-transient simulations.
+ New buoyantSimpleRadiationFoam solver for steady-state, buoyant, turbulent
flow of compressible fluids with radiation, for ventilation and
heat-transfer.
+ New rhoTurbTwinParcelFoam solver for transient for compressible, turbulent
flow with two thermo-clouds.
+ New gnemdFOAM solver for general purpose molecular dynamics that simulates
atoms in arbitrary shaped domains and average atomic/molecular quantities to
the mesh to create field data.
+ New mdEqulibrationFoam solver to equilibrates and/or preconditions molecular
dynamics systems.
+ Demonstration SRFSimpleFoam solver based on simpleFoam that incorporates the
SRF extensions (see below) for rotating flows.
* Automatic mesher
New snappyHexMesh utility that generates split-hex meshes automatically from
triangulated (STL) surface geometries. The mesh approximately conforms to
the surface by iteratively refining a starting mesh and morphing the
resulting split-hex mesh to the surface. An optional phase will shrink back
the resulting mesh and insert cell layers. It has a flexible specification
of mesh refinement level and robust surface handling with a pre-specified
final mesh quality. It runs in parallel with a load balancing step every
iteration.
* Developments to utilities
+ New extrude2DMesh utility that extrudes 2D meshes into a 3D mesh. 2D meshes
are described by faces with 2 points, so can be used in combination with 2D
meshes converted with ccm26ToFoam.
+ New couplePatches functionality integrated into createPatch, which
optionally synchronises ("couples") points and faces of coupled (cyclic,
processor) patches.
+ New applyBoundaryLayer pre-processing utility to apply 1/7th power-law
boundary layers at walls, starting from uniform or potential flow solutions.
+ New execFlowFunctionObjects utility executes functionObjects as a
post-processing activity, e.g. probes, sampling, force calculation.
+ New changeDictionary utility makes batch changes to OpenFOAM input files,
e.g. to change boundary conditions of field files.
+ New foamCalc utility, a generic post-processing field calculator tool
+ New molConfig pre-processing utility for molecular dynamics cases. Fills
zones of a mesh with single crystal lattices of specified structure,
density, orientation, alignment and temperature.
+ Extended splitMeshRegions utility to split multi-zone meshes, e.g. defined
through cellZones, into separate meshes.
+ Extended the foamToVTK, decomposePar, reconstructPar and mapFields utilities
to include support for multiple particle clouds in parallel processing.
* Migration from ParaView 2.4 to ParaView 3.x
+ Rewritten OpenFOAM Reader Module for version 3, a major redesign of
ParaView.
+ New features include viewing patch names, reading of Lagrangian data,
handling of cell, face and point sets, multiple views.
* Model development
+ Overhauled the lagrangian library to support multiple clouds.
+ New lagrangianIntermediate library incorporating a hierarchy of parcel and
cloud types, accommodating kinematic, thermodynamic and reacting
applications, including coupling to the new radiation library. Sub-models
are added at the relevant level of physics, e.g.:
- kinematic: injection, wall interaction, drag, dispersion;
- thermo: heat transfer;
- reacting: reacting composition, mass transfer, surface reactions.
+ New single rotating frame of reference (SRF) library for rotating flow
applications, e.g. turbo-machinery.
+ New radiation library including the P1 model and associated Marshak boundary
conditions for incident radiation.
+ New displacementInterpolation motion solver for flexible mesh scaling.
+ New molecularDynamics Lagrangian library to calculate intermolecular forces
between spherically symmetrical monatomic species in arbitrary geometries.
* New functionObjects
To aid common monitoring and post-processing activities.
+ forces: calculate the force and moment on a patch or set of patches, e.g. to
calculate the lift, drag and moment of an object in the flow.
+ forceCoeffs: calculate the normalised force and moment on a patch or set of
patches, e.g. to calculate the lift, drag and moment coefficients of an
object in the flow.
+ fieldAverage: calculate field arithmetic mean and prime-squared averages for
a list of fields.
+ foamCalcFunctions: calculate field components, div, mag, magGrad or magSqr.
* Improvements to boundary conditions
+ Generalised jumpCyclic type: cyclic condition with an additional prescribed
jump in value.
+ fan type: specialisation of jumpCyclic, applying a prescribed jump in
pressure to simulate a fan within a mesh.
+ Generalised advective outflow boundary condition based on solving D/Dt(psi,
U) = 0 at the boundary.
+ Additional turbulent flow inlet to specify mixing length and frequency.
+ Generalisation of time varying set of boundary conditions.
* Other
+ New argument-free command execution, e.g typing "icoFoam" without root and
case directory arguments.
+ Extended time command line options.
+ Many enhancements to dictionary including macro substitution, optional
merging and default/overwrite behaviour, enhanced "#include" file handling
and the framework to support function evaluation.
+ Cross-links between applications and Doxygen documentation with the "-doc"
argument.
+ Non-blocking, non-buffered, parallel transfers with potential scaling
benefits for larger number of processors.

View File

@ -1,213 +1,235 @@
# -*- mode: org; -*- # -*- mode: org; -*-
# #
#+TITLE: OpenFOAM release notes for version 1.6 #+TITLE: *OpenFOAM release notes for version 1.6*
#+AUTHOR: OpenCFD Ltd. #+AUTHOR: OpenCFD Ltd.
#+DATE: 29 August 2009 #+DATE: July 2009
#+LINK: http://www.opencfd.co.uk #+LINK: http://www.opencfd.co.uk
#+OPTIONS: author:nil ^:{} #+OPTIONS: author:nil ^:{}
* Overview
OpenFOAM-1.6 is is a significant upgrade to version 1.5 in ways which are
outlined below. This release passes all our standard tests and the tutorials
have been broadly checked. If there are any bugs, please report them using
the instructions set out in: http://www.OpenFOAM.org/bugs.html.
* Regular Expressions * GNU/Linux version
+ new regExp class: support for accessing POSIX extended regular The 32bit and 64bit binary packs of the OpenFOAM release were compiled on a
expresssions from within OpenFOAM. machine running SuSE GNU/Linux version 11.1 and also tested on Ubuntu 9. We
recommend that users run OpenFOAM on one of these or a similar recent version
of GNU/Linux. This release has also been successfully compiled and tested on
older GNU/Linux releases but this requires the installation of Qt 4.3.? (the
sources for which are supplied with OpenFOAM-1.6, see README) for ParaView-3
to run.
+ new wordRe class: can contain a word or a regExp. * C++ Compiler version
The match() method matches appropriately (as word or regExp). + Release compiled with GCC 4.3.3.
+ Built in support for the Intel C++ 10.? compiler (untested).
+ The choice of the compiler is controlled by the setting of the
~$WM_COMPILER~ and ~$WM_COMPILER_ARCH~ environment variables in the
/OpenFOAM-1.6/etc/bashrc/ (or /cshrc/) file.
+ The location of the installation of the compiler is controlled by the
~$compilerInstall~ environment variable in the
/OpenFOAM-1.6/etc/settings.sh/ (or /settings.csh/) file.
+ new stringListOps: search string lists based on regular expressions, wordRe * Library developments
or wordReList.
+ Istream and Ostream now retain backslashes when reading/writing strings. *** Turbulence modelling
The backslash continues to be used as an escape character for double-quote + Major development of turbulence model libraries to give extra flexibility
and newline, but otherwise get passed through "as-is" without any other at the solver level. For solvers that can support either RAS/LES
special meaning (ie, they are *not* C-style strings). This especially computations, the selection is made in the
helps with input/output of regular expressions. /constant/turbulenceProperties/,
by setting the =simulationType= keyword to:
- =laminar=
- =RASModel=
- =LESModel=
+ Depending on the selection, the model is the instantiated from /constant//
- /RASProperties/
- /LESProperties/
***** RAS wall functions
Wall functions are now run-time selectable per patch for RAS.
* Dictionary improvements/changes ******* Velocity:
+ dictionaries can use words (unquoted) or regular expressions (quoted) + Apply to turbulent viscosities =nut= or =mut=
for their keywords. When searching, an exact match has priority + Apply to =k=, =Q=, =R=
over a regular expression match. + Apply to =epsilon=, =omega=
+ The default inputMode is now 'merge', which corresponds to the most ******* Temperature:
general usage. The inputMode 'warn' corresponds to the previous default + Apply to turbulent thermal diffusivity, =alphat= (compressible only)
behaviour.
+ The new inputMode 'protect' can be used to conditionally merge default ******* To apply wall functions:
values into existing dictionaries. + To recapture the functionality of previous OpenFOAM versions (v1.5 and
earlier) assign:
- for velocity:
- =nut=: =nutWallFunction=
- =mut=: =muWallFunction=
- =epsilon=: =epsilonWallFunction=
- =omega=: =omegaWallFunction=
- =k=, =Q=, =R=: =kQRWallFunction=
- for temperature:
- =alphat=: =alphatWallFunction=
+ New =alphaSgsJayatillekeWallFunction= thermal wall function for
compressible LES
+ new digest() method to calculate and return the SHA1 message digest ***** *New* LES turbulence models
+ Spalart-Allmaras DDES
+ Spalart-Allmaras IDDES
***** Upgrading:
+ *New* utility - =applyWallFunctionBoundaryConditions=
+ Solvers will automatically update existing cases
- New fields created based on the presence of the =nut/mut= field
- Boundary conditions include scoping, i.e compressibility:: for
compressible solvers
- Modified fields will be backed-up to /<field>.old/
+ NOTE:
- Fields are only updated for those fields associated with the current
turbulence model selection, i.e. if fields exist for use with other
models, they will not be updated
- New specification is not backwards compatible
* Improved List containers *** Thermo-physical Models
+ It is now possible to append a UList to an existing List or DynamicList. + Old compressibility based thermo package renamed
=basicThermo= \rightarrow =basicPsiThermo=
+ *New* =basicRhoThermo= thermo package
- Additional density field stored
- General form - can be used for other types of media, e.g. liquids
- Additional polynomial-based thermodynamics
- Equation of state: =icoPolynomial=
- Transport: =polynomialTransport=
- Thermo: =hPolynomialThermo=
+ Removed earlier hard-coding of gas thermophysics for chemistry modelling:
- =reactingMixture= now templated on thermo package
- =chemistryModel= now templated on thermo package
- =chemistrySolver= now templated on thermo package
+ *New* =fvDOM= radition model
- finite volume, discrete ordinates method
+ *New* (reinstated) =eThermo= thermodynamics package
- internal energy based thermodynamics
+ DynamicList is now much more flexible. It can be used with the append() *** Lagrangian
method, or with the setSize() method and operator[], as per List.
DynamicList also has more methods for adjusting the space allocated.
+ SortableList now uses stable sort and allows reverseSort as well. ***** Intermediate
SortableList is also more versatile - the indices mostly remain - Overhaul of the underlying framework
unallocated until they are required in the sort() method. - Reacting now split into reacting and reacting multiphase
The sort indices can be deallocated with the shrink() method. - New structure for variable composition
Works as expected with transfer() and assignment from other Lists. - Many new sub-models, including:
- Injection
- =PatchInjection= - injection local to patch face cells
- =FieldActivatedInjection= - injection based on satisfying external
criterion
- LookupTableInjection - explicity define injection locations and all
parcel properties
- Post-processing
- patch post-processing - collect data for parcels impacting user
defined patches
- Patch interaction
- generalised behaviour for parcel interaction with patch
- Phase change
- liquid evaporation
+ specialization for UList<bool>::operator[](..) const to return false for ***** Coal combustion
out-of-range elements. This allows lazy evaluation with no noticeable - *New* library - extension of reacting-multiphase functionality
change in performance. - Surface reaction/combustion models
+ PackedList has much better performance, lazy evaluation and auto-vivify *** Discrete methods
of elements on assignment. Any auto-vivified elements will also - *New* library offering DSMC simulation functionality - see =dsmcFoam=
flood-fill the gaps with zero. The append() method can be used like in below
DynamicList to append a single element. The set() method can be used - *New* libraries offering molecular dynamics simulation functionality - see
like in labelHashSet. =mdFoam= and =mdEquilibrationFoam=: below.
+ new UIndirectList for an indirect list without storing the addressing. * Solver restructuring
The upgrade to the turbulence models means that the simulation type, i.e.
laminar, RAS or LES can be selected at run time. This has allowed a reduction
in the number of solvers, simplifying the overall code structure
+ Solvers which support laminar, RAS and LES:
- =turbFoam=, =oodles= \rightarrow =pisoFoam=
- =turbDyMFoam= \rightarrow =pimpleDyMFoam=
- =rhoTurbFoam=, =coodles= \rightarrow =rhoPisoFoam=
- =xoodles= \rightarrow absorbed into =XiFoam=
- =buoyantFoam=, =lesBuoyantFoam= \rightarrow =buoyantPisoFoam=
- =interFoam=, rasInterFoam, =lesInterFoam= \rightarrow =interFoam=
- =lesCavitatingFoam=, =rasCavitatingFoam= \rightarrow =cavitatingFoam=
+ Solvers which support LES only:
- =channelOodles= \rightarrow =channelFoam= (LES)
* General changes
- pd to p ------------------------------------------------------------ [HENRY]
- gravity ------------------------------------------------------------ [HENRY]
* New hashing algorithms * Tutorial restructuring
+ Bob Jenkins' hash routine for performance improvement (5-10% faster for to reflect solver application structure
string hashing than the previous algorithm) and fewer collisions.
+ SHA1 hashing and SHA1 message digests (NIST specification FIPS-180-1) * Post-processing ---------------------------------------------------- [MATTIJS]
added. The SHA1 digest provides a compact (20 bytes) means of - SAMPLING - improved plane, iso-surface handling
determining if the contents of an object have changed. The OSHA1stream
can be used to calculate SHA1 digests for anything that can write to an
output stream.
* *New* Solvers
+ =buoyantBoussinesqSimpleFoam=
Steady state heat transfer solver using a Boussinesq approximation for
buoyancy, with laminar, RAS or LES turbulence modelling
* HashTable/HashSet improvements + =buoyantBoussinesqPisoFoam=
+ Performance improvements for querying on empty tables Transient heat transfer solver using a Boussinesq approximation for
buoyancy, with laminar, RAS or LES turbulence modelling
+ The erase() method can take a list of keys or the keys from any + =coalChemistryFoam=
another HashTable/HashSet. Transient, reacting lagrangian solver, employing a coal cloud and a thermo
cloud, with chemistry, and laminar, RAS or LES turbulence modelling
+ HashSet has an operator[]() const that allows the same syntax + =porousExplicitSourceReactingParcelFoam=
to be used for boolList, PackedBoolList and labelHashSet. Transient, reacting lagrangian solver, employing a single phase reacting
cloud, with porous media, explicit mass sources, and laminar, RAS or LES
turbulence modelling
+ HashSet has additional operators '+=', '-=', '&=' to add, remove or + =rhoReactingFoam=
intersect keys, respectively. Density-based thermodynamics variant of the reactingFoam solver, i.e. now
applicable to liquid systems
+ =dsmcFoam=
DSMC (Direct Simulation Monte-Carlo) solver for rarefied gas dynamics
simultions, able to simulate mixtures of an arbitrary number of gas species.
The variable hard sphere collision model with Larsen-Borgnakke internal
energy redistribution (see "Molecular Gas Dynamics and the Direct Simulation
of Gas Flows" G.A. Bird, 1994) is available; other run-time selectable
collision models can be easily added.
* Improved bool/Switch * Updated solvers
+ Switch: reduced the storage to be on par with bool. + =mdFoam=
It is now more flexible and behaves much more like a bool. Molecular Dynamics (MD) solver able to simulate a mixture of an arbitrary
number of mono-atomic and small, rigid polyatomic (i.e. H2O, N2) molecular
species, with 6 degree of freedom motion, in complex geometries. A molecule
of any species can be built by specifying its sites of mass and charge. All
molecules interact with short-range dispersion forces and pairwise
electrostatic interactions using methods described in:
Fennell and Gezelter, J. Chem. Phys. 124, 234104 (2006)
+ bool: IO uses Switch internally so the end-user doesn't need to know if + =mdEquilibrationFoam=
a particular class used bool or Switch internally. Similar to mdFoam, but employs velocity scaling to adjust the simulation
temperature to a target value. Useful to equilibrate a case before
simulation.
* Function objects
* Miscellaneous container class improvments *** *New* function objects:
+ boost-style StaticAssert added. - =systemCall= - executes a list of system instructions
Useful to catch invalid template sizes, for example. - =fieldMinMax= - computes the min/max of a <field>
- =staticPressure= - converts kinematic pressure to static pressure
- =dsmcFields= - calculates intensive fields (velocity and temperature) from
averaged extensive fields (i.e. momentum and energy)
+ various containers now have C++0x-style cbegin(), cend() iterator methods. *** Usage
- Improved output control: =timeStep= or =outputTime=
+ various containers now have STL-style empty() method, which may be more * Boundary conditions
readable than !size() or !valid(). - Improved set of direct mapped boundary conditions
- Buoyancy boundary condition ---------------------------------------- [HENRY]
+ various containers now have an xfer() method for yielding their contents * *New* utilities
to a corresponding Xfer class. - =particleTracks= - generate particle tracks for lagrangian calculations
- =dsmcInitialise= - preprocessing utility to create initial configurations of
DSMC particles in a geometry
* New surfMesh library
Provides a more efficient storage mechanism than possible with triSurface
without restrictions on the shape of the face (templated parameter).
It will however take quite some time before it can fully replace triSurface.
+ MeshedSurface class: with zero or more contiguous surfZones.
+ UnsortedMeshedSurface class: unordered surface zones (as per triSurface)
+ surfMesh class: for reading/writing in native OpenFOAM format
* New Xfer class
Provides finer grained control over copying or transferring objects with
very little overhead. It can be used for any object that has a transfer()
method and a operator=() copy method.
Since it is decided upon construction of the Xfer object whether the
parameter is to be copied or transferred, the contents of the resulting
Xfer object can be transferred unconditionally. This greatly simplifies
defining constructors or methods in other classes with mixed
transfer/copy semantics without requiring 2^N different versions.
+ xferCopy(), xferMove() and xferCopyTo(), xferMoveTo() functions
to ease the use of the Xfer class.
* Improvements for functionObjects and time-looping
+ The functionObjectList retains the order of the functionObject order,
which allows a chaining of operations. It is thus internally more
efficient when system/controlDict uses functions {..} instead of
functions (..), but the both forms are supported.
+ The functionObjects now have an additional end() method that gets called
when Time::loop() or Time::run() determines that the time-loop exits.
Accordingly, one of these two idioms should be used in solver code:
1. while (runTime.loop() { ... }
2. while (runTime.run()) { runTime++; ... }
+ functionObjectList now tracks the SHA1 message digest of the
sub-directories. This avoids reloading a functionObject when something
unrelated in system/controlDict changed.
* Solver control improvments
Use dictionary entries instead of an Istream for the solver controls.
+ allows dictionary substitutions and regular expressions in
system/fvSolution
+ old solver control syntax is still supported (warning emitted), but the
foamUpgradeFvSolution application can be used to convert
system/fvSolution to the new format.
* Convenience changes
+ IOobject: new constructor for creating an IOobject from a
single-path specification (eg, see blockMesh -dict option).
+ argList: convenience methods for accessing options more directly.
option(), optionFound(), optionLookup(), optionRead(),
optionReadIfPresent().
+ readList(Istream&) can read a bracket-delimited list or handle a single
value as a list of size 1. This can be a useful convenience when
processing command-line options.
* Misc. improvements
+ improved consistency and interoperability between face and triFace classes.
+ face::triangles() can split and append to a DynamicList
+ coordinateSystems can access global systems (similar to MeshObject)
* Improvements to utilities
+ blockMesh: -dict option for specifying an alternative dictionary for the
block mesh description. The 'convertToMeters' entry is now optional, and
the alternative 'scale' entry can be used for less typing.
+ foamToEnsight: the -noPatches option suppresses generation of patches
+ foamToEnsightParts: the -noMesh option and the -index option can
be used when post-processing incrementally.
+ timeSelector: can combine -time ranges and -latestTime options. More
reliable behaviour for cases missing constant/ or 0/ directories. When
the -noZero option is available, -latestTime will not select the 0/
directory unless the -zeroTime option is also given. This helps avoid
ill effects caused by accidentally using the 0/ directory for certain
utilities (eg, reconstructPar).
* Improvements to Paraview reader module
+ PV3FoamReader: added mesh region handling. The region name is parsed
from the filename. Eg, case{region}.OpenFOAM
+ paraFoam: new -region option for specifying an alternative region. A new
-touch option to generate the .OpenFOAM file only. Only creates (and
removes) .OpenFOAM files if they didn't already exist, which is useful
in connection with the -touch option.
*** *New* foamCalc functions
- =interpolate= - performs fvc::interpolate(<field>)
- =randomise= - randomises a <field> by a given perturbation
- =addSubtract= - simple add/subtract field functionality

View File

@ -7,6 +7,8 @@
rho*g rho*g
); );
UEqn.relax();
if (momentumPredictor) if (momentumPredictor)
{ {
solve(UEqn == -fvc::grad(p)); solve(UEqn == -fvc::grad(p));

View File

@ -87,12 +87,12 @@ int main(int argc, char *argv[])
runTime++; runTime++;
Info<< "Time = " << runTime.timeName() << nl << endl; Info<< "Time = " << runTime.timeName() << nl << endl;
// --- Pressure-velocity PIMPLE corrector loop
for (int oCorr=0; oCorr<nOuterCorr; oCorr++)
{
#include "rhoEqn.H" #include "rhoEqn.H"
#include "UEqn.H" #include "UEqn.H"
// --- PISO loop
for (int corr=1; corr<=nCorr; corr++)
{
#include "ftEqn.H" #include "ftEqn.H"
#include "bEqn.H" #include "bEqn.H"
#include "huEqn.H" #include "huEqn.H"
@ -103,10 +103,14 @@ int main(int argc, char *argv[])
hu == h; hu == h;
} }
// --- PISO loop
for (int corr=1; corr<=nCorr; corr++)
{
#include "pEqn.H" #include "pEqn.H"
} }
turbulence->correct(); turbulence->correct();
}
rho = thermo.rho(); rho = thermo.rho();

View File

@ -52,7 +52,7 @@ if (ign.ignited())
+ mvConvection->fvmDiv(phi, b) + mvConvection->fvmDiv(phi, b)
+ fvm::div(phiSt, b, "div(phiSt,b)") + fvm::div(phiSt, b, "div(phiSt,b)")
- fvm::Sp(fvc::div(phiSt), b) - fvm::Sp(fvc::div(phiSt), b)
- fvm::laplacian(turbulence->muEff(), b) - fvm::laplacian(turbulence->alphaEff(), b)
); );
@ -90,7 +90,7 @@ if (ign.ignited())
// ~~~~~~~~~~~~~~~~~ // ~~~~~~~~~~~~~~~~~
surfaceScalarField phiXi = surfaceScalarField phiXi =
phiSt phiSt
- fvc::interpolate(fvc::laplacian(turbulence->muEff(), b)/mgb)*nf - fvc::interpolate(fvc::laplacian(turbulence->alphaEff(), b)/mgb)*nf
+ fvc::interpolate(rho)*fvc::interpolate(Su*(1.0/Xi - Xi))*nf; + fvc::interpolate(rho)*fvc::interpolate(Su*(1.0/Xi - Xi))*nf;

View File

@ -17,6 +17,6 @@ if (composition.contains("ft"))
( (
fvm::ddt(rho, ft) fvm::ddt(rho, ft)
+ mvConvection->fvmDiv(phi, ft) + mvConvection->fvmDiv(phi, ft)
- fvm::laplacian(turbulence->muEff(), ft) - fvm::laplacian(turbulence->alphaEff(), ft)
); );
} }

View File

@ -1,5 +1,5 @@
{ {
solve fvScalarMatrix hEqn
( (
fvm::ddt(rho, h) fvm::ddt(rho, h)
+ mvConvection->fvmDiv(phi, h) + mvConvection->fvmDiv(phi, h)
@ -8,5 +8,8 @@
DpDt DpDt
); );
hEqn.relax();
hEqn.solve();
thermo.correct(); thermo.correct();
} }

View File

@ -68,10 +68,10 @@ int main(int argc, char *argv[])
#include "chemistry.H" #include "chemistry.H"
#include "rhoEqn.H" #include "rhoEqn.H"
#include "UEqn.H"
for (label ocorr=1; ocorr <= nOuterCorr; ocorr++) for (label ocorr=1; ocorr <= nOuterCorr; ocorr++)
{ {
#include "UEqn.H"
#include "YEqn.H" #include "YEqn.H"
#include "hEqn.H" #include "hEqn.H"

View File

@ -82,15 +82,21 @@ Foam::objectRegistry::objectRegistry
Foam::objectRegistry::~objectRegistry() Foam::objectRegistry::~objectRegistry()
{ {
List<regIOobject*> myObjects(size());
label nMyObjects = 0;
for (iterator iter = begin(); iter != end(); ++iter) for (iterator iter = begin(); iter != end(); ++iter)
{ {
if (iter()->ownedByRegistry()) if (iter()->ownedByRegistry())
{ {
regIOobject* object = iter(); myObjects[nMyObjects++] = iter();
erase(iter);
delete object;
} }
} }
for (label i=0; i<nMyObjects; i++)
{
checkOut(*myObjects[i]);
}
} }

View File

@ -32,7 +32,7 @@ inline bool Foam::regIOobject::ownedByRegistry() const
} }
void Foam::regIOobject::store() inline void Foam::regIOobject::store()
{ {
ownedByRegistry_ = true; ownedByRegistry_ = true;
} }
@ -74,18 +74,18 @@ inline Type& Foam::regIOobject::store(autoPtr<Type>& atPtr)
} }
void Foam::regIOobject::release() inline void Foam::regIOobject::release()
{ {
ownedByRegistry_ = false; ownedByRegistry_ = false;
} }
Foam::label Foam::regIOobject::eventNo() const inline Foam::label Foam::regIOobject::eventNo() const
{ {
return eventNo_; return eventNo_;
} }
Foam::label& Foam::regIOobject::eventNo() inline Foam::label& Foam::regIOobject::eventNo()
{ {
return eventNo_; return eventNo_;
} }

View File

@ -63,7 +63,10 @@ void Foam::fieldAverage::addMeanField
const fieldType& baseField = const fieldType& baseField =
obr_.lookupObject<fieldType>(fieldName); obr_.lookupObject<fieldType>(fieldName);
fieldType* fPtr = new fieldType // Store on registry
obr_.store
(
new fieldType
( (
IOobject IOobject
( (
@ -73,12 +76,10 @@ void Foam::fieldAverage::addMeanField
IOobject::READ_IF_PRESENT, IOobject::READ_IF_PRESENT,
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
baseField 1*baseField
)
); );
// Store on registry
fPtr->store();
meanFieldList[fieldI] = meanFieldName; meanFieldList[fieldI] = meanFieldName;
} }
} }
@ -121,7 +122,9 @@ void Foam::fieldAverage::addPrime2MeanField
const fieldType1& meanField = const fieldType1& meanField =
obr_.lookupObject<fieldType1>(meanFieldList[fieldI]); obr_.lookupObject<fieldType1>(meanFieldList[fieldI]);
fieldType2* fPtr = new fieldType2 obr_.store
(
new fieldType2
( (
IOobject IOobject
( (
@ -132,11 +135,9 @@ void Foam::fieldAverage::addPrime2MeanField
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
sqr(baseField) - sqr(meanField) sqr(baseField) - sqr(meanField)
)
); );
// Store on registry
fPtr->store();
prime2MeanFieldList[fieldI] = meanFieldName; prime2MeanFieldList[fieldI] = meanFieldName;
} }
} }

View File

@ -108,6 +108,7 @@ void fixedEnthalpyFvPatchScalarField::updateCoeffs()
fvPatchScalarField& Tw = fvPatchScalarField& Tw =
const_cast<fvPatchScalarField&>(thermo.T().boundaryField()[patchi]); const_cast<fvPatchScalarField&>(thermo.T().boundaryField()[patchi]);
Tw.evaluate(); Tw.evaluate();
operator==(thermo.h(Tw, patchi)); operator==(thermo.h(Tw, patchi));
fixedValueFvPatchScalarField::updateCoeffs(); fixedValueFvPatchScalarField::updateCoeffs();

View File

@ -75,7 +75,6 @@ LESModel::LESModel
) )
), ),
turbulence_(lookup("turbulence")),
printCoeffs_(lookupOrDefault<Switch>("printCoeffs", false)), printCoeffs_(lookupOrDefault<Switch>("printCoeffs", false)),
coeffDict_(subDictPtr(type + "Coeffs")), coeffDict_(subDictPtr(type + "Coeffs")),

View File

@ -80,7 +80,6 @@ protected:
// Protected data // Protected data
Switch turbulence_;
Switch printCoeffs_; Switch printCoeffs_;
dictionary coeffDict_; dictionary coeffDict_;

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,50 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 |
| \\ / A nd | Web: http://www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volTensorField;
object B;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -2 0 0 0 0];
internalField uniform (0 0 0 0 0 0 0 0 0);
boundaryField
{
inlet
{
type fixedValue;
value uniform (0 0 0 0 0 0 0 0 0);
}
outlet
{
type zeroGradient;
}
upperWall
{
type zeroGradient;
}
lowerWall
{
type zeroGradient;
}
frontAndBack
{
type empty;
}
}
// ************************************************************************* //

View File

@ -33,11 +33,15 @@ boundaryField
upperWall upperWall
{ {
type zeroGradient; type zeroGradient;
//type compressible::alphaSgsWallFunction;
value uniform 0;
} }
lowerWall lowerWall
{ {
type zeroGradient; type zeroGradient;
//type compressible::alphaSgsWallFunction;
value uniform 0;
} }
frontAndBack frontAndBack

View File

@ -35,14 +35,14 @@ boundaryField
upperWall upperWall
{ {
type fixedValue; type zeroGradient;
value uniform 1e-8; value uniform 2e-05;
} }
lowerWall lowerWall
{ {
type fixedValue; type zeroGradient;
value uniform 1e-8; value uniform 2e-05;
} }
frontAndBack frontAndBack

View File

@ -33,11 +33,15 @@ boundaryField
upperWall upperWall
{ {
type zeroGradient; type zeroGradient;
//type compressible::muSgsWallFunction;
value uniform 0;
} }
lowerWall lowerWall
{ {
type zeroGradient; type zeroGradient;
//type compressible::muSgsWallFunction;
value uniform 0;
} }
frontAndBack frontAndBack

View File

@ -19,21 +19,21 @@ laminarFlameSpeedCorrelation constant;
fuel Propane; fuel Propane;
Su Su [ 0 1 -1 0 0 0 0 ] 0.135; Su Su [0 1 -1 0 0 0 0] 0.135;
SuModel transport; SuModel unstrained;
equivalenceRatio equivalenceRatio [ 0 0 0 0 0 0 0 ] 0.6; equivalenceRatio equivalenceRatio [0 0 0 0 0 0 0] 0.6;
sigmaExt sigmaExt [ 0 0 -1 0 0 0 0 ] 338; sigmaExt sigmaExt [0 0 -1 0 0 0 0] 338;
XiModel transport; XiModel transport;
XiCoef XiCoef [ 0 0 0 0 0 0 0 ] 0.62; XiCoef XiCoef [0 0 0 0 0 0 0] 0.62;
XiShapeCoef XiShapeCoef [ 0 0 0 0 0 0 0 ] 1; XiShapeCoef XiShapeCoef [0 0 0 0 0 0 0] 1;
uPrimeCoef uPrimeCoef [ 0 0 0 0 0 0 0 ] 1; uPrimeCoef uPrimeCoef [0 0 0 0 0 0 0] 1;
GuldersCoeffs GuldersCoeffs
{ {
@ -68,17 +68,26 @@ GuldersCoeffs
} }
} }
ignite no; ignite yes;
ignitionSites ( ); ignitionSites
(
{
location (0.005 -0.02 0);
diameter 0.003;
start 0;
duration 0.1;
strength 40;
}
);
ignitionSphereFraction 0; ignitionSphereFraction 0;
ignitionThickness ignitionThickness [ 0 1 0 0 0 0 0 ] 0; ignitionThickness ignitionThickness [0 1 0 0 0 0 0] 0.001;
ignitionCircleFraction 0; ignitionCircleFraction 1;
ignitionKernelArea ignitionKernelArea [ 0 2 0 0 0 0 0 ] 0; ignitionKernelArea ignitionKernelArea [0 2 0 0 0 0 0] 0;
// ************************************************************************* // // ************************************************************************* //

View File

@ -17,7 +17,7 @@ FoamFile
application XiFoam; application XiFoam;
startFrom startTime; startFrom latestTime;
startTime 0; startTime 0;
@ -27,9 +27,9 @@ endTime 10;
deltaT 5e-06; deltaT 5e-06;
writeControl runTime; writeControl adjustableRunTime;
writeInterval 0.1; writeInterval 0.01;
purgeWrite 0; purgeWrite 0;

View File

@ -38,7 +38,14 @@ divSchemes
div(phiXi,Xi) Gauss limitedLinear 1; div(phiXi,Xi) Gauss limitedLinear 1;
div(phiXi,Su) Gauss limitedLinear 1; div(phiXi,Su) Gauss limitedLinear 1;
div(phiSt,b) Gauss limitedLinear01 1; div(phiSt,b) Gauss limitedLinear01 1;
div(phi,ft_b_h_hu) Gauss multivariateSelection { fu limitedLinear01 1 ; ft limitedLinear01 1 ; b limitedLinear01 1 ; h limitedLinear 1 ; hu limitedLinear 1 ; }; div(phi,ft_b_h_hu) Gauss multivariateSelection
{
fu limitedLinear01 1;
ft limitedLinear01 1;
b limitedLinear01 1;
h limitedLinear 1;
hu limitedLinear 1;
};
div(U) Gauss linear; div(U) Gauss linear;
div((Su*grad(b))) Gauss linear; div((Su*grad(b))) Gauss linear;
div((U+((Su*Xi)*grad(b)))) Gauss linear; div((U+((Su*Xi)*grad(b)))) Gauss linear;
@ -52,8 +59,8 @@ laplacianSchemes
laplacian(DkEff,k) Gauss linear corrected; laplacian(DkEff,k) Gauss linear corrected;
laplacian(DBEff,B) Gauss linear corrected; laplacian(DBEff,B) Gauss linear corrected;
laplacian((rho*(1|A(U))),p) Gauss linear corrected; laplacian((rho*(1|A(U))),p) Gauss linear corrected;
laplacian(muEff,b) Gauss linear corrected; laplacian(alphaEff,b) Gauss linear corrected;
laplacian(muEff,ft) Gauss linear corrected; laplacian(alphaEff,ft) Gauss linear corrected;
laplacian(alphaEff,h) Gauss linear corrected; laplacian(alphaEff,h) Gauss linear corrected;
laplacian(alphaEff,hu) Gauss linear corrected; laplacian(alphaEff,hu) Gauss linear corrected;
} }

View File

@ -124,6 +124,7 @@ solvers
PISO PISO
{ {
nOuterCorrectors 1;
nCorrectors 2; nCorrectors 2;
nNonOrthogonalCorrectors 0; nNonOrthogonalCorrectors 0;
} }

View File

@ -19,21 +19,21 @@ laminarFlameSpeedCorrelation Gulders;
fuel Propane; fuel Propane;
Su Su [ 0 1 -1 0 0 0 0 ] 0.135; Su Su [0 1 -1 0 0 0 0] 0.135;
SuModel transport; SuModel transport;
equivalenceRatio equivalenceRatio [ 0 0 0 0 0 0 0 ] 0.6; equivalenceRatio equivalenceRatio [0 0 0 0 0 0 0] 0.6;
sigmaExt sigmaExt [ 0 0 -1 0 0 0 0 ] 338; sigmaExt sigmaExt [0 0 -1 0 0 0 0] 338;
XiModel transport; XiModel transport;
XiCoef XiCoef [ 0 0 0 0 0 0 0 ] 0.62; XiCoef XiCoef [0 0 0 0 0 0 0] 0.62;
XiShapeCoef XiShapeCoef [ 0 0 0 0 0 0 0 ] 1; XiShapeCoef XiShapeCoef [0 0 0 0 0 0 0] 1;
uPrimeCoef uPrimeCoef [ 0 0 0 0 0 0 0 ] 1; uPrimeCoef uPrimeCoef [0 0 0 0 0 0 0] 1;
GuldersCoeffs GuldersCoeffs
{ {
@ -70,15 +70,24 @@ GuldersCoeffs
ignite yes; ignite yes;
ignitionSites ( { location ( 0 0 0 ) ; diameter 0.003 ; start 0 ; duration 0.001 ; strength 2 ; } ); ignitionSites
(
{
location (0 0 0);
diameter 0.003;
start 0;
duration 0.001;
strength 2;
}
);
ignitionSphereFraction 1; ignitionSphereFraction 1;
ignitionThickness ignitionThickness [ 0 1 0 0 0 0 0 ] 0; ignitionThickness ignitionThickness [0 1 0 0 0 0 0] 0;
ignitionCircleFraction 0; ignitionCircleFraction 0;
ignitionKernelArea ignitionKernelArea [ 0 2 0 0 0 0 0 ] 0; ignitionKernelArea ignitionKernelArea [0 2 0 0 0 0 0] 0;
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,45 +10,44 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
( inlet 5
(
inlet
{ {
type patch; type patch;
startFace 715675;
nFaces 600; nFaces 600;
startFace 715675;
} }
outlet outlet
{ {
type patch; type patch;
startFace 716275;
nFaces 1140; nFaces 1140;
startFace 716275;
} }
upperWall upperWall
{ {
type wall; type wall;
startFace 717415;
nFaces 4460; nFaces 4460;
startFace 717415;
} }
lowerWall lowerWall
{ {
type wall; type wall;
startFace 721875;
nFaces 5000; nFaces 5000;
startFace 721875;
} }
frontAndBack frontAndBack
{ {
type cyclic; type cyclic;
startFace 726875;
nFaces 24450; nFaces 24450;
startFace 726875;
featureCos 0.9;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -27,7 +27,7 @@ endTime 0.02;
deltaT 5e-06; deltaT 5e-06;
writeControl runTime; writeControl adjustableRunTime;
writeInterval 0.0005; writeInterval 0.0005;

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -890,7 +890,7 @@
(0.092027148309198 0.043035802795154 -7.5111607367588e-05) (0.092027148309198 0.043035802795154 -7.5111607367588e-05)
(0.09263207221129 0.043855929103565 -7.65429970772772e-05) (0.09263207221129 0.043855929103565 -7.65429970772772e-05)
(0.093192171617555 0.044640776830937 -7.79128140787704e-05) (0.093192171617555 0.044640776830937 -7.79128140787704e-05)
(0.093752202168401 0.045432032540685 -7.92938151136726e-05) (0.093752202168401 0.045432032540685 -7.92938151136725e-05)
(0.094312245417969 0.046226095413819 -8.067971557046e-05) (0.094312245417969 0.046226095413819 -8.067971557046e-05)
(0.09487228896823 0.047021673078023 -8.20682598350704e-05) (0.09487228896823 0.047021673078023 -8.20682598350704e-05)
(0.095432330811069 0.047818192791575 -8.34584482851299e-05) (0.095432330811069 0.047818192791575 -8.34584482851299e-05)
@ -33658,7 +33658,7 @@
(0.092027148309198 0.043035802795154 7.5111607367588e-05) (0.092027148309198 0.043035802795154 7.5111607367588e-05)
(0.09263207221129 0.043855929103565 7.65429970772772e-05) (0.09263207221129 0.043855929103565 7.65429970772772e-05)
(0.093192171617555 0.044640776830937 7.79128140787704e-05) (0.093192171617555 0.044640776830937 7.79128140787704e-05)
(0.093752202168401 0.045432032540685 7.92938151136726e-05) (0.093752202168401 0.045432032540685 7.92938151136725e-05)
(0.094312245417969 0.046226095413819 8.067971557046e-05) (0.094312245417969 0.046226095413819 8.067971557046e-05)
(0.09487228896823 0.047021673078023 8.20682598350704e-05) (0.09487228896823 0.047021673078023 8.20682598350704e-05)
(0.095432330811069 0.047818192791575 8.34584482851299e-05) (0.095432330811069 0.047818192791575 8.34584482851299e-05)

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,53 +10,49 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
6 6
( (
front front
{ {
type wall; type wall;
nFaces 700; nFaces 700;
startFace 63400; startFace 63400;
} }
back
back {
{
type wall; type wall;
nFaces 700; nFaces 700;
startFace 64100; startFace 64100;
} }
wall
wall {
{
type wall; type wall;
nFaces 1400; nFaces 1400;
startFace 64800; startFace 64800;
} }
porosityWall
porosityWall {
{
type wall; type wall;
nFaces 1600; nFaces 1600;
startFace 66200; startFace 66200;
} }
inlet
inlet {
{
type patch; type patch;
nFaces 400; nFaces 400;
startFace 67800; startFace 67800;
} }
outlet
outlet {
{
type patch; type patch;
nFaces 400; nFaces 400;
startFace 68200; startFace 68200;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -0,0 +1,58 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format binary;
class polyBoundaryMesh;
location "constant/polyMesh";
object boundary;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
6
(
front
{
type wall;
nFaces 700;
startFace 63400;
}
back
{
type wall;
nFaces 700;
startFace 64100;
}
wall
{
type wall;
nFaces 1400;
startFace 64800;
}
porosityWall
{
type wall;
nFaces 1600;
startFace 66200;
}
inlet
{
type patch;
nFaces 400;
startFace 67800;
}
outlet
{
type patch;
nFaces 400;
startFace 68200;
}
)
// ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,53 +10,49 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
6 6
( (
inlet inlet
{ {
type patch; type patch;
nFaces 50; nFaces 50;
startFace 10325; startFace 10325;
} }
outlet
outlet {
{
type patch; type patch;
nFaces 40; nFaces 40;
startFace 10375; startFace 10375;
} }
bottom
bottom {
{
type symmetryPlane; type symmetryPlane;
nFaces 25; nFaces 25;
startFace 10415; startFace 10415;
} }
top
top {
{
type symmetryPlane; type symmetryPlane;
nFaces 125; nFaces 125;
startFace 10440; startFace 10440;
} }
obstacle
obstacle {
{
type patch; type patch;
nFaces 110; nFaces 110;
startFace 10565; startFace 10565;
} }
defaultFaces
defaultFaces {
{
type empty; type empty;
nFaces 10500; nFaces 10500;
startFace 10675; startFace 10675;
} }
) )
// ************************************************************************* // // ************************************************************************* //

File diff suppressed because it is too large Load Diff

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volVectorField; class volVectorField;
location "0";
object U; object U;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -24,11 +25,11 @@ boundaryField
{ {
type zeroGradient; type zeroGradient;
} }
empty empty
{ {
type empty; type empty;
} }
} }
// ************************************************************************* // // ************************************************************************* //

File diff suppressed because it is too large Load Diff

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,25 +10,25 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
2 2
( (
sides sides
{ {
type patch; type patch;
nFaces 2; nFaces 2;
startFace 999; startFace 999;
} }
empty
empty {
{
type empty; type empty;
nFaces 4000; nFaces 4000;
startFace 1001; startFace 1001;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,25 +10,25 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
2 2
( (
sides sides
{ {
type patch; type patch;
nFaces 2; nFaces 2;
startFace 99; startFace 99;
} }
empty
empty {
{
type empty; type empty;
nFaces 400; nFaces 400;
startFace 101; startFace 101;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,53 +10,49 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
6 6
( (
inlet inlet
{ {
type patch; type patch;
nFaces 40; nFaces 40;
startFace 9440; startFace 9440;
} }
outlet
outlet {
{
type patch; type patch;
nFaces 40; nFaces 40;
startFace 9480; startFace 9480;
} }
bottom
bottom {
{
type symmetryPlane; type symmetryPlane;
nFaces 40; nFaces 40;
startFace 9520; startFace 9520;
} }
top
top {
{
type symmetryPlane; type symmetryPlane;
nFaces 120; nFaces 120;
startFace 9560; startFace 9560;
} }
obstacle
obstacle {
{
type patch; type patch;
nFaces 80; nFaces 80;
startFace 9680; startFace 9680;
} }
defaultFaces
defaultFaces {
{
type empty; type empty;
nFaces 9600; nFaces 9600;
startFace 9760; startFace 9760;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,53 +10,49 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
6 6
( (
inlet inlet
{ {
type patch; type patch;
nFaces 50; nFaces 50;
startFace 10325; startFace 10325;
} }
outlet
outlet {
{
type patch; type patch;
nFaces 40; nFaces 40;
startFace 10375; startFace 10375;
} }
bottom
bottom {
{
type symmetryPlane; type symmetryPlane;
nFaces 25; nFaces 25;
startFace 10415; startFace 10415;
} }
top
top {
{
type symmetryPlane; type symmetryPlane;
nFaces 125; nFaces 125;
startFace 10440; startFace 10440;
} }
obstacle
obstacle {
{
type patch; type patch;
nFaces 110; nFaces 110;
startFace 10565; startFace 10565;
} }
defaultFaces
defaultFaces {
{
type empty; type empty;
nFaces 10500; nFaces 10500;
startFace 10675; startFace 10675;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,25 +10,25 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
2 2
( (
sides sides
{ {
type patch; type patch;
nFaces 2; nFaces 2;
startFace 999; startFace 999;
} }
empty
empty {
{
type empty; type empty;
nFaces 4000; nFaces 4000;
startFace 1001; startFace 1001;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,39 +10,37 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
4 4
( (
INLE1 INLE1
{ {
type patch; type patch;
nFaces 400; nFaces 400;
startFace 79570; startFace 79570;
} }
OUTL2
OUTL2 {
{
type patch; type patch;
nFaces 200; nFaces 200;
startFace 79970; startFace 79970;
} }
SYMP3
SYMP3 {
{
type empty; type empty;
nFaces 80000; nFaces 80000;
startFace 80170; startFace 80170;
} }
WALL10
WALL10 {
{
type wall; type wall;
nFaces 260; nFaces 260;
startFace 160170; startFace 160170;
} }
) )
// ************************************************************************* // // ************************************************************************* //

View File

@ -23,13 +23,13 @@ startTime 0;
stopAt endTime; stopAt endTime;
endTime 0.03; endTime 0.01;
deltaT 4e-08; deltaT 4e-08;
writeControl runTime; writeControl runTime;
writeInterval 1e-05; writeInterval 2e-04;
purgeWrite 0; purgeWrite 0;

View File

@ -0,0 +1,56 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
location "0";
object alphat;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -1 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type calculated;
value uniform 0;
}
outlet
{
type calculated;
value uniform 0;
}
bottomWall
{
type calculated;
value uniform 0;
}
topWall
{
type calculated;
value uniform 0;
}
prismWall
{
type compressible::alphatWallFunction;
value uniform 0;
}
defaultFaces
{
type empty;
}
}
// ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
location "0";
object epsilon; object epsilon;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -25,37 +26,34 @@ boundaryField
type fixedValue; type fixedValue;
value uniform 266000; value uniform 266000;
} }
outlet outlet
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 266000; inletValue uniform 266000;
value uniform 266000; value uniform 266000;
} }
bottomWall bottomWall
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 266000; inletValue uniform 266000;
value uniform 266000; value uniform 266000;
} }
topWall topWall
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 266000; inletValue uniform 266000;
value uniform 266000; value uniform 266000;
} }
prismWall prismWall
{ {
type zeroGradient; type compressible::epsilonWallFunction;
value uniform 266000;
} }
defaultFaces defaultFaces
{ {
type empty; type empty;
} }
} }
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
location "0";
object k; object k;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -25,37 +26,34 @@ boundaryField
type fixedValue; type fixedValue;
value uniform 1000; value uniform 1000;
} }
outlet outlet
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 1000; inletValue uniform 1000;
value uniform 1000; value uniform 1000;
} }
bottomWall bottomWall
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 1000; inletValue uniform 1000;
value uniform 1000; value uniform 1000;
} }
topWall topWall
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 1000; inletValue uniform 1000;
value uniform 1000; value uniform 1000;
} }
prismWall prismWall
{ {
type zeroGradient; type compressible::kQRWallFunction;
value uniform 1000;
} }
defaultFaces defaultFaces
{ {
type empty; type empty;
} }
} }
// ************************************************************************* // // ************************************************************************* //

View File

@ -0,0 +1,56 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
location "0";
object mut;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -1 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type calculated;
value uniform 0;
}
outlet
{
type calculated;
value uniform 0;
}
bottomWall
{
type calculated;
value uniform 0;
}
topWall
{
type calculated;
value uniform 0;
}
prismWall
{
type mutWallFunction;
value uniform 0;
}
defaultFaces
{
type empty;
}
}
// ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -0,0 +1,24 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "0/uniform/lagrangian/dsmc";
object particleProperties;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
processor0
{
particleCount 63978;
}
// ************************************************************************* //

View File

@ -0,0 +1,24 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "0/uniform/lagrangian/dsmc";
object particleProperties;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
processor0
{
particleCount 63978;
}
// ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,11 +10,12 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object ft; location "0";
object Ux;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 0 0 0 0 0 0]; dimensions [0 1 -1 0 0 0 0];
internalField uniform 0; internalField uniform 0;
@ -22,31 +23,29 @@ boundaryField
{ {
inlet inlet
{ {
type fixedValue; type calculated;
value uniform 0; value uniform 1;
} }
outlet outlet
{ {
type inletOutlet; type calculated;
inletValue uniform 0;
value uniform 0; value uniform 0;
} }
upperWall
{
type zeroGradient;
}
lowerWall lowerWall
{ {
type zeroGradient; type calculated;
value uniform 0;
}
upperWall
{
type calculated;
value uniform 0;
} }
frontAndBack frontAndBack
{ {
type empty; type empty;
} }
} }
// ************************************************************************* // // ************************************************************************* //

View File

@ -0,0 +1,51 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
location "0";
object Uy;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 1 -1 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type calculated;
value uniform 0;
}
outlet
{
type calculated;
value uniform 0;
}
lowerWall
{
type calculated;
value uniform 0;
}
upperWall
{
type calculated;
value uniform 0;
}
frontAndBack
{
type empty;
}
}
// ************************************************************************* //

View File

@ -0,0 +1,51 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
location "0";
object Uz;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 1 -1 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type calculated;
value uniform 0;
}
outlet
{
type calculated;
value uniform 0;
}
lowerWall
{
type calculated;
value uniform 0;
}
upperWall
{
type calculated;
value uniform 0;
}
frontAndBack
{
type empty;
}
}
// ************************************************************************* //

View File

@ -1,7 +1,7 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5-8cbffd16687e | | \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -0,0 +1,76 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class polyBoundaryMesh;
location "constant/polyMesh";
object boundary;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
9
(
maxY
{
type empty;
nFaces 0;
startFace 60456;
}
minX
{
type empty;
nFaces 0;
startFace 60456;
}
maxX
{
type empty;
nFaces 0;
startFace 60456;
}
minY
{
type empty;
nFaces 0;
startFace 60456;
}
ground
{
type wall;
nFaces 590;
startFace 60456;
}
maxZ
{
type empty;
nFaces 0;
startFace 61046;
}
igloo_region0
{
type wall;
nFaces 2260;
startFace 61046;
}
twoFridgeFreezers_seal_0
{
type wall;
nFaces 1344;
startFace 63306;
}
twoFridgeFreezers_herring_1
{
type wall;
nFaces 1116;
startFace 64650;
}
)
// ************************************************************************* //

View File

@ -11,30 +11,35 @@ FoamFile
format ascii; format ascii;
class volScalarField; class volScalarField;
location "0"; location "0";
object epsilon; object alphat;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 2 -3 0 0 0 0]; dimensions [1 -1 -1 0 0 0 0];
internalField uniform 0.01; internalField uniform 0;
boundaryField boundaryField
{ {
box
{
type compressible::alphatWallFunction;
value uniform 0;
}
floor floor
{ {
type compressible::epsilonWallFunction; type compressible::alphatWallFunction;
value uniform 0.01; value uniform 0;
} }
ceiling ceiling
{ {
type compressible::epsilonWallFunction; type compressible::alphatWallFunction;
value uniform 0.01; value uniform 0;
} }
fixedWalls fixedWalls
{ {
type compressible::epsilonWallFunction; type compressible::alphatWallFunction;
value uniform 0.01; value uniform 0;
} }
} }

View File

@ -15,34 +15,31 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [ 0 2 -3 0 0 0 0 ]; dimensions [0 2 -3 0 0 0 0];
internalField uniform 0.01; internalField uniform 0.01;
boundaryField boundaryField
{ {
floor
{
type compressible::epsilonWallFunction;
value uniform 0;
}
ceiling
{
type compressible::epsilonWallFunction;
value uniform 0;
}
fixedWalls
{
type compressible::epsilonWallFunction;
value uniform 0;
}
box box
{ {
type compressible::epsilonWallFunction; type compressible::epsilonWallFunction;
value uniform 0; value uniform 0.01;
}
floor
{
type compressible::epsilonWallFunction;
value uniform 0.01;
}
ceiling
{
type compressible::epsilonWallFunction;
value uniform 0.01;
}
fixedWalls
{
type compressible::epsilonWallFunction;
value uniform 0.01;
} }
} }

View File

@ -15,34 +15,31 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [ 0 2 -2 0 0 0 0 ]; dimensions [0 2 -2 0 0 0 0];
internalField uniform 0.1; internalField uniform 0.1;
boundaryField boundaryField
{ {
floor
{
type compressible::kQRWallFunction;
value uniform 0;
}
ceiling
{
type compressible::kQRWallFunction;
value uniform 0;
}
fixedWalls
{
type compressible::kQRWallFunction;
value uniform 0;
}
box box
{ {
type compressible::kQRWallFunction; type compressible::kQRWallFunction;
value uniform 0; value uniform 0.1;
}
floor
{
type compressible::kQRWallFunction;
value uniform 0.1;
}
ceiling
{
type compressible::kQRWallFunction;
value uniform 0.1;
}
fixedWalls
{
type compressible::kQRWallFunction;
value uniform 0.1;
} }
} }

View File

@ -11,30 +11,35 @@ FoamFile
format ascii; format ascii;
class volScalarField; class volScalarField;
location "0"; location "0";
object k; object mut;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 2 -2 0 0 0 0]; dimensions [1 -1 -1 0 0 0 0];
internalField uniform 0.1; internalField uniform 0;
boundaryField boundaryField
{ {
box
{
type mutWallFunction;
value uniform 0;
}
floor floor
{ {
type compressible::kQRWallFunction; type mutWallFunction;
value uniform 0.1; value uniform 0;
} }
ceiling ceiling
{ {
type compressible::kQRWallFunction; type mutWallFunction;
value uniform 0.1; value uniform 0;
} }
fixedWalls fixedWalls
{ {
type compressible::kQRWallFunction; type mutWallFunction;
value uniform 0.1; value uniform 0;
} }
} }

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format ascii; format binary;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh"; location "constant/polyMesh";
object boundary; object boundary;

Some files were not shown because too many files have changed in this diff Show More