diff --git a/ReleaseNotes-1.5 b/ReleaseNotes-1.5 deleted file mode 100644 index fab8b8826e..0000000000 --- a/ReleaseNotes-1.5 +++ /dev/null @@ -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. diff --git a/ReleaseNotes-1.6 b/ReleaseNotes-1.6 index 3abe7072e2..0fe2691f91 100644 --- a/ReleaseNotes-1.6 +++ b/ReleaseNotes-1.6 @@ -1,213 +1,235 @@ # -*- mode: org; -*- # -#+TITLE: OpenFOAM release notes for version 1.6 +#+TITLE: *OpenFOAM release notes for version 1.6* #+AUTHOR: OpenCFD Ltd. -#+DATE: 29 August 2009 +#+DATE: July 2009 #+LINK: http://www.opencfd.co.uk #+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 - + new regExp class: support for accessing POSIX extended regular - expresssions from within OpenFOAM. +* GNU/Linux version + The 32bit and 64bit binary packs of the OpenFOAM release were compiled on a + 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. - The match() method matches appropriately (as word or regExp). +* C++ Compiler version + + 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 - or wordReList. +* Library developments - + Istream and Ostream now retain backslashes when reading/writing strings. - The backslash continues to be used as an escape character for double-quote - and newline, but otherwise get passed through "as-is" without any other - special meaning (ie, they are *not* C-style strings). This especially - helps with input/output of regular expressions. +*** Turbulence modelling + + Major development of turbulence model libraries to give extra flexibility + at the solver level. For solvers that can support either RAS/LES + computations, the selection is made in the + /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 - + dictionaries can use words (unquoted) or regular expressions (quoted) - for their keywords. When searching, an exact match has priority - over a regular expression match. +******* Velocity: + + Apply to turbulent viscosities =nut= or =mut= + + Apply to =k=, =Q=, =R= + + Apply to =epsilon=, =omega= - + The default inputMode is now 'merge', which corresponds to the most - general usage. The inputMode 'warn' corresponds to the previous default - behaviour. +******* Temperature: + + Apply to turbulent thermal diffusivity, =alphat= (compressible only) - + The new inputMode 'protect' can be used to conditionally merge default - values into existing dictionaries. +******* To apply wall functions: + + 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 /.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 - + It is now possible to append a UList to an existing List or DynamicList. +*** Thermo-physical Models + + 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() - method, or with the setSize() method and operator[], as per List. - DynamicList also has more methods for adjusting the space allocated. +*** Lagrangian - + SortableList now uses stable sort and allows reverseSort as well. - SortableList is also more versatile - the indices mostly remain - unallocated until they are required in the sort() method. - The sort indices can be deallocated with the shrink() method. - Works as expected with transfer() and assignment from other Lists. +***** Intermediate + - Overhaul of the underlying framework + - Reacting now split into reacting and reacting multiphase + - New structure for variable composition + - 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::operator[](..) const to return false for - out-of-range elements. This allows lazy evaluation with no noticeable - change in performance. +***** Coal combustion + - *New* library - extension of reacting-multiphase functionality + - Surface reaction/combustion models - + PackedList has much better performance, lazy evaluation and auto-vivify - of elements on assignment. Any auto-vivified elements will also - flood-fill the gaps with zero. The append() method can be used like in - DynamicList to append a single element. The set() method can be used - like in labelHashSet. +*** Discrete methods + - *New* library offering DSMC simulation functionality - see =dsmcFoam= + below + - *New* libraries offering molecular dynamics simulation functionality - see + =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 - + Bob Jenkins' hash routine for performance improvement (5-10% faster for - string hashing than the previous algorithm) and fewer collisions. +* Tutorial restructuring + to reflect solver application structure - + SHA1 hashing and SHA1 message digests (NIST specification FIPS-180-1) - added. The SHA1 digest provides a compact (20 bytes) means of - 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. +* Post-processing ---------------------------------------------------- [MATTIJS] + - SAMPLING - improved plane, iso-surface handling +* *New* Solvers + + =buoyantBoussinesqSimpleFoam= + Steady state heat transfer solver using a Boussinesq approximation for + buoyancy, with laminar, RAS or LES turbulence modelling -* HashTable/HashSet improvements - + Performance improvements for querying on empty tables + + =buoyantBoussinesqPisoFoam= + 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 - another HashTable/HashSet. + + =coalChemistryFoam= + 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 - to be used for boolList, PackedBoolList and labelHashSet. + + =porousExplicitSourceReactingParcelFoam= + 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 - intersect keys, respectively. + + =rhoReactingFoam= + 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 - + Switch: reduced the storage to be on par with bool. - It is now more flexible and behaves much more like a bool. +* Updated solvers + + =mdFoam= + 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 - a particular class used bool or Switch internally. + + =mdEquilibrationFoam= + 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 - + boost-style StaticAssert added. - Useful to catch invalid template sizes, for example. +*** *New* function objects: + - =systemCall= - executes a list of system instructions + - =fieldMinMax= - computes the min/max of a + - =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 - readable than !size() or !valid(). +* Boundary conditions + - Improved set of direct mapped boundary conditions + - Buoyancy boundary condition ---------------------------------------- [HENRY] - + various containers now have an xfer() method for yielding their contents - to a corresponding Xfer class. - - -* 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* utilities + - =particleTracks= - generate particle tracks for lagrangian calculations + - =dsmcInitialise= - preprocessing utility to create initial configurations of + DSMC particles in a geometry +*** *New* foamCalc functions + - =interpolate= - performs fvc::interpolate() + - =randomise= - randomises a by a given perturbation + - =addSubtract= - simple add/subtract field functionality diff --git a/applications/solvers/combustion/XiFoam/UEqn.H b/applications/solvers/combustion/XiFoam/UEqn.H index 2a7753e14e..9697c6e1ed 100644 --- a/applications/solvers/combustion/XiFoam/UEqn.H +++ b/applications/solvers/combustion/XiFoam/UEqn.H @@ -7,6 +7,8 @@ rho*g ); + UEqn.relax(); + if (momentumPredictor) { solve(UEqn == -fvc::grad(p)); diff --git a/applications/solvers/combustion/XiFoam/XiFoam.C b/applications/solvers/combustion/XiFoam/XiFoam.C index 4c544b433e..6e804be977 100644 --- a/applications/solvers/combustion/XiFoam/XiFoam.C +++ b/applications/solvers/combustion/XiFoam/XiFoam.C @@ -87,12 +87,12 @@ int main(int argc, char *argv[]) runTime++; Info<< "Time = " << runTime.timeName() << nl << endl; - #include "rhoEqn.H" - #include "UEqn.H" - - // --- PISO loop - for (int corr=1; corr<=nCorr; corr++) + // --- Pressure-velocity PIMPLE corrector loop + for (int oCorr=0; oCorrcorrect(); + turbulence->correct(); + } rho = thermo.rho(); diff --git a/applications/solvers/combustion/XiFoam/bEqn.H b/applications/solvers/combustion/XiFoam/bEqn.H index 33ef24bfe6..d06ec2e5f0 100644 --- a/applications/solvers/combustion/XiFoam/bEqn.H +++ b/applications/solvers/combustion/XiFoam/bEqn.H @@ -52,7 +52,7 @@ if (ign.ignited()) + mvConvection->fvmDiv(phi, b) + fvm::div(phiSt, b, "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 = 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; diff --git a/applications/solvers/combustion/XiFoam/ftEqn.H b/applications/solvers/combustion/XiFoam/ftEqn.H index 519cbd7cbe..46d7aeae82 100644 --- a/applications/solvers/combustion/XiFoam/ftEqn.H +++ b/applications/solvers/combustion/XiFoam/ftEqn.H @@ -1,7 +1,7 @@ tmp > mvConvection ( fv::convectionScheme::New - ( + ( mesh, fields, phi, @@ -17,6 +17,6 @@ if (composition.contains("ft")) ( fvm::ddt(rho, ft) + mvConvection->fvmDiv(phi, ft) - - fvm::laplacian(turbulence->muEff(), ft) + - fvm::laplacian(turbulence->alphaEff(), ft) ); } diff --git a/applications/solvers/combustion/XiFoam/hEqn.H b/applications/solvers/combustion/XiFoam/hEqn.H index ebce30e24e..513ae60441 100644 --- a/applications/solvers/combustion/XiFoam/hEqn.H +++ b/applications/solvers/combustion/XiFoam/hEqn.H @@ -1,5 +1,5 @@ { - solve + fvScalarMatrix hEqn ( fvm::ddt(rho, h) + mvConvection->fvmDiv(phi, h) @@ -8,5 +8,8 @@ DpDt ); + hEqn.relax(); + hEqn.solve(); + thermo.correct(); } diff --git a/applications/solvers/combustion/rhoReactingFoam/rhoReactingFoam.C b/applications/solvers/combustion/rhoReactingFoam/rhoReactingFoam.C index 680bd784e0..578d8c051c 100644 --- a/applications/solvers/combustion/rhoReactingFoam/rhoReactingFoam.C +++ b/applications/solvers/combustion/rhoReactingFoam/rhoReactingFoam.C @@ -68,10 +68,10 @@ int main(int argc, char *argv[]) #include "chemistry.H" #include "rhoEqn.H" - #include "UEqn.H" for (label ocorr=1; ocorr <= nOuterCorr; ocorr++) { + #include "UEqn.H" #include "YEqn.H" #include "hEqn.H" diff --git a/src/OpenFOAM/db/objectRegistry/objectRegistry.C b/src/OpenFOAM/db/objectRegistry/objectRegistry.C index 9d01de9d90..452ad35ac6 100644 --- a/src/OpenFOAM/db/objectRegistry/objectRegistry.C +++ b/src/OpenFOAM/db/objectRegistry/objectRegistry.C @@ -82,15 +82,21 @@ Foam::objectRegistry::objectRegistry Foam::objectRegistry::~objectRegistry() { + List myObjects(size()); + label nMyObjects = 0; + for (iterator iter = begin(); iter != end(); ++iter) { if (iter()->ownedByRegistry()) { - regIOobject* object = iter(); - erase(iter); - delete object; + myObjects[nMyObjects++] = iter(); } } + + for (label i=0; i& atPtr) } -void Foam::regIOobject::release() +inline void Foam::regIOobject::release() { ownedByRegistry_ = false; } -Foam::label Foam::regIOobject::eventNo() const +inline Foam::label Foam::regIOobject::eventNo() const { return eventNo_; } -Foam::label& Foam::regIOobject::eventNo() +inline Foam::label& Foam::regIOobject::eventNo() { return eventNo_; } diff --git a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C index a69dce41b7..4e59e8a30b 100644 --- a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C +++ b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C @@ -63,21 +63,22 @@ void Foam::fieldAverage::addMeanField const fieldType& baseField = obr_.lookupObject(fieldName); - fieldType* fPtr = new fieldType - ( - IOobject - ( - meanFieldName, - obr_.time().timeName(), - obr_, - IOobject::READ_IF_PRESENT, - IOobject::NO_WRITE - ), - baseField - ); - // Store on registry - fPtr->store(); + obr_.store + ( + new fieldType + ( + IOobject + ( + meanFieldName, + obr_.time().timeName(), + obr_, + IOobject::READ_IF_PRESENT, + IOobject::NO_WRITE + ), + 1*baseField + ) + ); meanFieldList[fieldI] = meanFieldName; } @@ -121,22 +122,22 @@ void Foam::fieldAverage::addPrime2MeanField const fieldType1& meanField = obr_.lookupObject(meanFieldList[fieldI]); - fieldType2* fPtr = new fieldType2 + obr_.store ( - IOobject + new fieldType2 ( - meanFieldName, - obr_.time().timeName(), - obr_, - IOobject::READ_IF_PRESENT, - IOobject::NO_WRITE - ), - sqr(baseField) - sqr(meanField) + IOobject + ( + meanFieldName, + obr_.time().timeName(), + obr_, + IOobject::READ_IF_PRESENT, + IOobject::NO_WRITE + ), + sqr(baseField) - sqr(meanField) + ) ); - // Store on registry - fPtr->store(); - prime2MeanFieldList[fieldI] = meanFieldName; } } diff --git a/src/thermophysicalModels/basic/derivedFvPatchFields/fixedEnthalpy/fixedEnthalpyFvPatchScalarField.C b/src/thermophysicalModels/basic/derivedFvPatchFields/fixedEnthalpy/fixedEnthalpyFvPatchScalarField.C index e409d243c8..19e345abe0 100644 --- a/src/thermophysicalModels/basic/derivedFvPatchFields/fixedEnthalpy/fixedEnthalpyFvPatchScalarField.C +++ b/src/thermophysicalModels/basic/derivedFvPatchFields/fixedEnthalpy/fixedEnthalpyFvPatchScalarField.C @@ -102,12 +102,13 @@ void fixedEnthalpyFvPatchScalarField::updateCoeffs() ( "thermophysicalProperties" ); - + const label patchi = patch().index(); - fvPatchScalarField& Tw = + fvPatchScalarField& Tw = const_cast(thermo.T().boundaryField()[patchi]); Tw.evaluate(); + operator==(thermo.h(Tw, patchi)); fixedValueFvPatchScalarField::updateCoeffs(); diff --git a/src/turbulenceModels/incompressible/LES/LESModel/LESModel.C b/src/turbulenceModels/incompressible/LES/LESModel/LESModel.C index 87d9f4fb41..fd755e8ea0 100644 --- a/src/turbulenceModels/incompressible/LES/LESModel/LESModel.C +++ b/src/turbulenceModels/incompressible/LES/LESModel/LESModel.C @@ -75,7 +75,6 @@ LESModel::LESModel ) ), - turbulence_(lookup("turbulence")), printCoeffs_(lookupOrDefault("printCoeffs", false)), coeffDict_(subDictPtr(type + "Coeffs")), diff --git a/src/turbulenceModels/incompressible/LES/LESModel/LESModel.H b/src/turbulenceModels/incompressible/LES/LESModel/LESModel.H index e5bd2545b8..620d4f0f55 100644 --- a/src/turbulenceModels/incompressible/LES/LESModel/LESModel.H +++ b/src/turbulenceModels/incompressible/LES/LESModel/LESModel.H @@ -80,7 +80,6 @@ protected: // Protected data - Switch turbulence_; Switch printCoeffs_; dictionary coeffDict_; diff --git a/tutorials/DNS/dnsFoam/boxTurb16/constant/polyMesh/boundary b/tutorials/DNS/dnsFoam/boxTurb16/constant/polyMesh/boundary index f4b0d0b918..8d533e8d83 100644 --- a/tutorials/DNS/dnsFoam/boxTurb16/constant/polyMesh/boundary +++ b/tutorials/DNS/dnsFoam/boxTurb16/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/B b/tutorials/combustion/XiFoam/les/pitzDaily/0/B deleted file mode 100644 index 42eef7d320..0000000000 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/B +++ /dev/null @@ -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; - } -} - -// ************************************************************************* // diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/Su b/tutorials/combustion/XiFoam/les/pitzDaily/0/Su index e5dea103a4..716a8510a4 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/Su +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/Su @@ -20,30 +20,30 @@ internalField uniform 0.135; boundaryField { - inlet + inlet { type fixedValue; value uniform 0.135; } - outlet + outlet { type inletOutlet; inletValue uniform 0.135; value uniform 0.135; } - upperWall + upperWall { type zeroGradient; } - lowerWall + lowerWall { type zeroGradient; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/T b/tutorials/combustion/XiFoam/les/pitzDaily/0/T index e112d66884..c4bae6fa13 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/T +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/T @@ -20,32 +20,32 @@ internalField uniform 293; boundaryField { - inlet + inlet { type fixedValue; value uniform 293; } - outlet + outlet { type inletOutlet; inletValue uniform 293; value uniform 293; } - upperWall + upperWall { type fixedValue; value uniform 293; } - lowerWall + lowerWall { type fixedValue; value uniform 293; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/Tu b/tutorials/combustion/XiFoam/les/pitzDaily/0/Tu index 9e8560d90b..3e1d003deb 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/Tu +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/Tu @@ -20,32 +20,32 @@ internalField uniform 293; boundaryField { - inlet + inlet { type fixedValue; value uniform 293; } - outlet + outlet { type inletOutlet; inletValue uniform 293; value uniform 293; } - upperWall + upperWall { type fixedValue; value uniform 293; } - lowerWall + lowerWall { type fixedValue; value uniform 293; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/U b/tutorials/combustion/XiFoam/les/pitzDaily/0/U index a69abfc235..d0f924b93e 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/U +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/U @@ -20,33 +20,33 @@ internalField uniform (0 0 0); boundaryField { - inlet + inlet { type turbulentInlet; referenceField uniform (13.3 0 0); fluctuationScale (0.04 0.02 0.02); } - outlet + outlet { type inletOutlet; inletValue uniform (0 0 0); value uniform (0 0 0); } - upperWall + upperWall { type fixedValue; value uniform (0 0 0); } - lowerWall + lowerWall { type fixedValue; value uniform (0 0 0); } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/Xi b/tutorials/combustion/XiFoam/les/pitzDaily/0/Xi index f1a4c1388d..299eca908c 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/Xi +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/Xi @@ -20,30 +20,30 @@ internalField uniform 1; boundaryField { - inlet + inlet { type fixedValue; value uniform 1; } - outlet + outlet { type inletOutlet; inletValue uniform 1; value uniform 1; } - upperWall + upperWall { type zeroGradient; } - lowerWall + lowerWall { type zeroGradient; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/alphaSgs b/tutorials/combustion/XiFoam/les/pitzDaily/0/alphaSgs index 9a83c0337e..24c919196b 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/alphaSgs +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/alphaSgs @@ -20,27 +20,31 @@ internalField uniform 0; boundaryField { - inlet + inlet { type zeroGradient; } - outlet + outlet { type zeroGradient; } - upperWall + upperWall { type zeroGradient; + //type compressible::alphaSgsWallFunction; + value uniform 0; } - lowerWall + lowerWall { type zeroGradient; + //type compressible::alphaSgsWallFunction; + value uniform 0; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/b b/tutorials/combustion/XiFoam/les/pitzDaily/0/b index b10da29e5a..5a487c3f1f 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/b +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/b @@ -20,30 +20,30 @@ internalField uniform 1; boundaryField { - inlet + inlet { type fixedValue; value uniform 1; } - outlet + outlet { type inletOutlet; inletValue uniform 1; value uniform 1; } - upperWall + upperWall { type zeroGradient; } - lowerWall + lowerWall { type zeroGradient; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/k b/tutorials/combustion/XiFoam/les/pitzDaily/0/k index 4544024e3b..43ac67fdfe 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/k +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/k @@ -35,14 +35,14 @@ boundaryField upperWall { - type fixedValue; - value uniform 1e-8; + type zeroGradient; + value uniform 2e-05; } lowerWall { - type fixedValue; - value uniform 1e-8; + type zeroGradient; + value uniform 2e-05; } frontAndBack diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/muSgs b/tutorials/combustion/XiFoam/les/pitzDaily/0/muSgs index 242527194d..a16e89fad9 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/muSgs +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/muSgs @@ -20,27 +20,31 @@ internalField uniform 0; boundaryField { - inlet + inlet { type zeroGradient; } - outlet + outlet { type zeroGradient; } - upperWall + upperWall { type zeroGradient; + //type compressible::muSgsWallFunction; + value uniform 0; } - lowerWall + lowerWall { type zeroGradient; + //type compressible::muSgsWallFunction; + value uniform 0; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/p b/tutorials/combustion/XiFoam/les/pitzDaily/0/p index a3351cfeb3..3700ec72b5 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/p +++ b/tutorials/combustion/XiFoam/les/pitzDaily/0/p @@ -20,28 +20,28 @@ internalField uniform 100000; boundaryField { - inlet + inlet { type zeroGradient; } - outlet + outlet { type fixedValue; value uniform 100000; } - upperWall + upperWall { type zeroGradient; } - lowerWall + lowerWall { type zeroGradient; } - frontAndBack + frontAndBack { type empty; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/constant/combustionProperties b/tutorials/combustion/XiFoam/les/pitzDaily/constant/combustionProperties index c82a1b4cc9..86fcfc889a 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/constant/combustionProperties +++ b/tutorials/combustion/XiFoam/les/pitzDaily/constant/combustionProperties @@ -19,21 +19,21 @@ laminarFlameSpeedCorrelation constant; 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; -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 { @@ -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; -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; // ************************************************************************* // diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/system/controlDict b/tutorials/combustion/XiFoam/les/pitzDaily/system/controlDict index 23b481bcaf..f5fe65e622 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/system/controlDict +++ b/tutorials/combustion/XiFoam/les/pitzDaily/system/controlDict @@ -17,7 +17,7 @@ FoamFile application XiFoam; -startFrom startTime; +startFrom latestTime; startTime 0; @@ -27,9 +27,9 @@ endTime 10; deltaT 5e-06; -writeControl runTime; +writeControl adjustableRunTime; -writeInterval 0.1; +writeInterval 0.01; purgeWrite 0; diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSchemes b/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSchemes index 78f524d421..e74dbeb191 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSchemes +++ b/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSchemes @@ -38,7 +38,14 @@ divSchemes div(phiXi,Xi) Gauss limitedLinear 1; div(phiXi,Su) Gauss limitedLinear 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((Su*grad(b))) Gauss linear; div((U+((Su*Xi)*grad(b)))) Gauss linear; @@ -52,8 +59,8 @@ laplacianSchemes laplacian(DkEff,k) Gauss linear corrected; laplacian(DBEff,B) Gauss linear corrected; laplacian((rho*(1|A(U))),p) Gauss linear corrected; - laplacian(muEff,b) Gauss linear corrected; - laplacian(muEff,ft) Gauss linear corrected; + laplacian(alphaEff,b) Gauss linear corrected; + laplacian(alphaEff,ft) Gauss linear corrected; laplacian(alphaEff,h) Gauss linear corrected; laplacian(alphaEff,hu) Gauss linear corrected; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSolution b/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSolution index cd3fb63f14..6e1d1ffd3e 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSolution +++ b/tutorials/combustion/XiFoam/les/pitzDaily/system/fvSolution @@ -124,6 +124,7 @@ solvers PISO { + nOuterCorrectors 1; nCorrectors 2; nNonOrthogonalCorrectors 0; } diff --git a/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/combustionProperties b/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/combustionProperties index 1568261fe2..8d2c6962d7 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/combustionProperties +++ b/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/combustionProperties @@ -19,21 +19,21 @@ laminarFlameSpeedCorrelation Gulders; 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; -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; -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 { @@ -70,15 +70,24 @@ GuldersCoeffs 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; -ignitionThickness ignitionThickness [ 0 1 0 0 0 0 0 ] 0; +ignitionThickness ignitionThickness [0 1 0 0 0 0 0] 0; ignitionCircleFraction 0; -ignitionKernelArea ignitionKernelArea [ 0 2 0 0 0 0 0 ] 0; +ignitionKernelArea ignitionKernelArea [0 2 0 0 0 0 0] 0; // ************************************************************************* // diff --git a/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/polyMesh/boundary b/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/polyMesh/boundary index e9e872c1a8..19a09dd2c7 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/polyMesh/boundary +++ b/tutorials/combustion/XiFoam/les/pitzDaily3D/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,45 +10,44 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -( inlet +5 +( + inlet { type patch; - startFace 715675; nFaces 600; + startFace 715675; } - outlet { type patch; - startFace 716275; nFaces 1140; + startFace 716275; } - upperWall { type wall; - startFace 717415; nFaces 4460; + startFace 717415; } - lowerWall { type wall; - startFace 721875; nFaces 5000; + startFace 721875; } - frontAndBack { type cyclic; - startFace 726875; nFaces 24450; + startFace 726875; + featureCos 0.9; } - ) // ************************************************************************* // diff --git a/tutorials/combustion/XiFoam/les/pitzDaily3D/system/controlDict b/tutorials/combustion/XiFoam/les/pitzDaily3D/system/controlDict index b9073e146d..cd473319ff 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily3D/system/controlDict +++ b/tutorials/combustion/XiFoam/les/pitzDaily3D/system/controlDict @@ -27,7 +27,7 @@ endTime 0.02; deltaT 5e-06; -writeControl runTime; +writeControl adjustableRunTime; writeInterval 0.0005; diff --git a/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/polyMesh/boundary b/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/polyMesh/boundary index 895e29387d..2c67db9e2b 100644 --- a/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/polyMesh/boundary +++ b/tutorials/combustion/XiFoam/ras/moriyoshiHomogeneous/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/polyMesh/boundary b/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/polyMesh/boundary index 42aaf838ff..fde0c49a89 100644 --- a/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoCentralFoam/LadenburgJet60psi/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/points.tmp b/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/points.tmp index 5b9e11a58a..6da3027bfa 100644 --- a/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/points.tmp +++ b/tutorials/compressible/rhoCentralFoam/biconic25-55Run35/constant/points.tmp @@ -890,7 +890,7 @@ (0.092027148309198 0.043035802795154 -7.5111607367588e-05) (0.09263207221129 0.043855929103565 -7.65429970772772e-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.09487228896823 0.047021673078023 -8.20682598350704e-05) (0.095432330811069 0.047818192791575 -8.34584482851299e-05) @@ -33658,7 +33658,7 @@ (0.092027148309198 0.043035802795154 7.5111607367588e-05) (0.09263207221129 0.043855929103565 7.65429970772772e-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.09487228896823 0.047021673078023 8.20682598350704e-05) (0.095432330811069 0.047818192791575 8.34584482851299e-05) diff --git a/tutorials/compressible/rhoCentralFoam/forwardStep/constant/polyMesh/boundary b/tutorials/compressible/rhoCentralFoam/forwardStep/constant/polyMesh/boundary index 492c762fdb..3309b5780a 100644 --- a/tutorials/compressible/rhoCentralFoam/forwardStep/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoCentralFoam/forwardStep/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/compressible/rhoCentralFoam/obliqueShock/constant/polyMesh/boundary b/tutorials/compressible/rhoCentralFoam/obliqueShock/constant/polyMesh/boundary index e04508a4d9..d3011e4e00 100644 --- a/tutorials/compressible/rhoCentralFoam/obliqueShock/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoCentralFoam/obliqueShock/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/compressible/rhoCentralFoam/shockTube/constant/polyMesh/boundary b/tutorials/compressible/rhoCentralFoam/shockTube/constant/polyMesh/boundary index 606cf5f91c..b77edc65ce 100644 --- a/tutorials/compressible/rhoCentralFoam/shockTube/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoCentralFoam/shockTube/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/compressible/rhoCentralFoam/wedge15Ma5/constant/polyMesh/boundary b/tutorials/compressible/rhoCentralFoam/wedge15Ma5/constant/polyMesh/boundary index 4dcb5b5d7f..454f459211 100644 --- a/tutorials/compressible/rhoCentralFoam/wedge15Ma5/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoCentralFoam/wedge15Ma5/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/polyMesh/boundary b/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/polyMesh/boundary index 540223e58f..0abd1608ab 100644 --- a/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoPimpleFoam/angledDuct/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,53 +10,49 @@ FoamFile version 2.0; format ascii; 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; -} + 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; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary new file mode 100644 index 0000000000..a664893343 --- /dev/null +++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary @@ -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; + } +) + +// ************************************************************************* // diff --git a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/boundary b/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/boundary index 9b47629860..2abc731c97 100644 --- a/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoSonicFoam/forwardStep/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,53 +10,49 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 6 ( -inlet -{ - type patch; - nFaces 50; - startFace 10325; -} - -outlet -{ - type patch; - nFaces 40; - startFace 10375; -} - -bottom -{ - type symmetryPlane; - nFaces 25; - startFace 10415; -} - -top -{ - type symmetryPlane; - nFaces 125; - startFace 10440; -} - -obstacle -{ - type patch; - nFaces 110; - startFace 10565; -} - -defaultFaces -{ - type empty; - nFaces 10500; - startFace 10675; -} + inlet + { + type patch; + nFaces 50; + startFace 10325; + } + outlet + { + type patch; + nFaces 40; + startFace 10375; + } + bottom + { + type symmetryPlane; + nFaces 25; + startFace 10415; + } + top + { + type symmetryPlane; + nFaces 125; + startFace 10440; + } + obstacle + { + type patch; + nFaces 110; + startFace 10565; + } + defaultFaces + { + type empty; + nFaces 10500; + startFace 10675; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0/T b/tutorials/compressible/rhoSonicFoam/shockTube/0/T index 6ad695f316..6caa8d38ec 100644 --- a/tutorials/compressible/rhoSonicFoam/shockTube/0/T +++ b/tutorials/compressible/rhoSonicFoam/shockTube/0/T @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,25 +10,1030 @@ FoamFile version 2.0; format ascii; class volScalarField; + location "0"; object T; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // dimensions [0 0 0 1 0 0 0]; -internalField uniform 1; +internalField nonuniform List +1000 +( +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +348.432 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +278.746 +) +; boundaryField { - sides + sides { type zeroGradient; } - - empty + empty { type empty; } } + // ************************************************************************* // diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0/U b/tutorials/compressible/rhoSonicFoam/shockTube/0/U index abe534b5fe..f0e3a05af4 100644 --- a/tutorials/compressible/rhoSonicFoam/shockTube/0/U +++ b/tutorials/compressible/rhoSonicFoam/shockTube/0/U @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class volVectorField; + location "0"; object U; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -20,15 +21,15 @@ internalField uniform (0 0 0); boundaryField { - sides + sides { type zeroGradient; } - - empty + empty { type empty; } } + // ************************************************************************* // diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/0/p b/tutorials/compressible/rhoSonicFoam/shockTube/0/p index 85c9743d30..2e4f54ab6d 100644 --- a/tutorials/compressible/rhoSonicFoam/shockTube/0/p +++ b/tutorials/compressible/rhoSonicFoam/shockTube/0/p @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,25 +10,1030 @@ FoamFile version 2.0; format ascii; class volScalarField; + location "0"; object p; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // dimensions [1 -1 -2 0 0 0 0]; -internalField uniform 0; +internalField nonuniform List +1000 +( +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +100000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +10000 +) +; boundaryField { - sides + sides { type zeroGradient; } - - empty + empty { type empty; } } + // ************************************************************************* // diff --git a/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/boundary b/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/boundary index 0f1a86e2ce..e4b48d35f4 100644 --- a/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/boundary +++ b/tutorials/compressible/rhoSonicFoam/shockTube/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,25 +10,25 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 2 ( -sides -{ - type patch; - nFaces 2; - startFace 999; -} - -empty -{ - type empty; - nFaces 4000; - startFace 1001; -} + sides + { + type patch; + nFaces 2; + startFace 999; + } + empty + { + type empty; + nFaces 4000; + startFace 1001; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/boundary b/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/boundary index 2e49b61dde..a38765097f 100644 --- a/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/boundary +++ b/tutorials/compressible/rhopSonicFoam/shockTube/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,25 +10,25 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 2 ( -sides -{ - type patch; - nFaces 2; - startFace 99; -} - -empty -{ - type empty; - nFaces 400; - startFace 101; -} + sides + { + type patch; + nFaces 2; + startFace 99; + } + empty + { + type empty; + nFaces 400; + startFace 101; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/boundary b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/boundary index a3ca808b34..454f459211 100644 --- a/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/boundary +++ b/tutorials/compressible/rhopSonicFoam/wedge15Ma5/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,53 +10,49 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 6 ( -inlet -{ - type patch; - nFaces 40; - startFace 9440; -} - -outlet -{ - type patch; - nFaces 40; - startFace 9480; -} - -bottom -{ - type symmetryPlane; - nFaces 40; - startFace 9520; -} - -top -{ - type symmetryPlane; - nFaces 120; - startFace 9560; -} - -obstacle -{ - type patch; - nFaces 80; - startFace 9680; -} - -defaultFaces -{ - type empty; - nFaces 9600; - startFace 9760; -} + inlet + { + type patch; + nFaces 40; + startFace 9440; + } + outlet + { + type patch; + nFaces 40; + startFace 9480; + } + bottom + { + type symmetryPlane; + nFaces 40; + startFace 9520; + } + top + { + type symmetryPlane; + nFaces 120; + startFace 9560; + } + obstacle + { + type patch; + nFaces 80; + startFace 9680; + } + defaultFaces + { + type empty; + nFaces 9600; + startFace 9760; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/laminar/forwardStep/constant/polyMesh/boundary b/tutorials/compressible/sonicFoam/laminar/forwardStep/constant/polyMesh/boundary index 9b47629860..2abc731c97 100644 --- a/tutorials/compressible/sonicFoam/laminar/forwardStep/constant/polyMesh/boundary +++ b/tutorials/compressible/sonicFoam/laminar/forwardStep/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,53 +10,49 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 6 ( -inlet -{ - type patch; - nFaces 50; - startFace 10325; -} - -outlet -{ - type patch; - nFaces 40; - startFace 10375; -} - -bottom -{ - type symmetryPlane; - nFaces 25; - startFace 10415; -} - -top -{ - type symmetryPlane; - nFaces 125; - startFace 10440; -} - -obstacle -{ - type patch; - nFaces 110; - startFace 10565; -} - -defaultFaces -{ - type empty; - nFaces 10500; - startFace 10675; -} + inlet + { + type patch; + nFaces 50; + startFace 10325; + } + outlet + { + type patch; + nFaces 40; + startFace 10375; + } + bottom + { + type symmetryPlane; + nFaces 25; + startFace 10415; + } + top + { + type symmetryPlane; + nFaces 125; + startFace 10440; + } + obstacle + { + type patch; + nFaces 110; + startFace 10565; + } + defaultFaces + { + type empty; + nFaces 10500; + startFace 10675; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/laminar/shockTube/constant/polyMesh/boundary b/tutorials/compressible/sonicFoam/laminar/shockTube/constant/polyMesh/boundary index 0f1a86e2ce..e4b48d35f4 100644 --- a/tutorials/compressible/sonicFoam/laminar/shockTube/constant/polyMesh/boundary +++ b/tutorials/compressible/sonicFoam/laminar/shockTube/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,25 +10,25 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 2 ( -sides -{ - type patch; - nFaces 2; - startFace 999; -} - -empty -{ - type empty; - nFaces 4000; - startFace 1001; -} + sides + { + type patch; + nFaces 2; + startFace 999; + } + empty + { + type empty; + nFaces 4000; + startFace 1001; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/polyMesh/boundary b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/polyMesh/boundary index cee40325b6..59a99aa3f0 100644 --- a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/polyMesh/boundary +++ b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,39 +10,37 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 4 ( -INLE1 -{ - type patch; - nFaces 400; - startFace 79570; -} - -OUTL2 -{ - type patch; - nFaces 200; - startFace 79970; -} - -SYMP3 -{ - type empty; - nFaces 80000; - startFace 80170; -} - -WALL10 -{ - type wall; - nFaces 260; - startFace 160170; -} + INLE1 + { + type patch; + nFaces 400; + startFace 79570; + } + OUTL2 + { + type patch; + nFaces 200; + startFace 79970; + } + SYMP3 + { + type empty; + nFaces 80000; + startFace 80170; + } + WALL10 + { + type wall; + nFaces 260; + startFace 160170; + } ) // ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/controlDict b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/controlDict index 2929b3f01f..c10b44bf2d 100644 --- a/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/controlDict +++ b/tutorials/compressible/sonicFoam/ras/nacaAirfoil/system/controlDict @@ -23,13 +23,13 @@ startTime 0; stopAt endTime; -endTime 0.03; +endTime 0.01; deltaT 4e-08; writeControl runTime; -writeInterval 1e-05; +writeInterval 2e-04; purgeWrite 0; diff --git a/tutorials/compressible/sonicFoam/ras/prism/0/alphat b/tutorials/compressible/sonicFoam/ras/prism/0/alphat new file mode 100644 index 0000000000..4eeae65666 --- /dev/null +++ b/tutorials/compressible/sonicFoam/ras/prism/0/alphat @@ -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; + } +} + + +// ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/ras/prism/0/epsilon b/tutorials/compressible/sonicFoam/ras/prism/0/epsilon index 18c90717aa..a7bd5b6bb0 100644 --- a/tutorials/compressible/sonicFoam/ras/prism/0/epsilon +++ b/tutorials/compressible/sonicFoam/ras/prism/0/epsilon @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class volScalarField; + location "0"; object epsilon; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -20,42 +21,39 @@ internalField uniform 266000; boundaryField { - inlet + inlet { type fixedValue; value uniform 266000; } - - outlet + outlet { type inletOutlet; inletValue uniform 266000; value uniform 266000; } - - bottomWall + bottomWall { type inletOutlet; inletValue uniform 266000; value uniform 266000; } - - topWall + topWall { type inletOutlet; inletValue uniform 266000; value uniform 266000; } - - prismWall + prismWall { - type zeroGradient; + type compressible::epsilonWallFunction; + value uniform 266000; } - - defaultFaces + defaultFaces { type empty; } } + // ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/ras/prism/0/k b/tutorials/compressible/sonicFoam/ras/prism/0/k index dc82052c52..77ca6b529a 100644 --- a/tutorials/compressible/sonicFoam/ras/prism/0/k +++ b/tutorials/compressible/sonicFoam/ras/prism/0/k @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class volScalarField; + location "0"; object k; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -20,42 +21,39 @@ internalField uniform 1000; boundaryField { - inlet + inlet { type fixedValue; value uniform 1000; } - - outlet + outlet { type inletOutlet; inletValue uniform 1000; value uniform 1000; } - - bottomWall + bottomWall { type inletOutlet; inletValue uniform 1000; value uniform 1000; } - - topWall + topWall { type inletOutlet; inletValue uniform 1000; value uniform 1000; } - - prismWall + prismWall { - type zeroGradient; + type compressible::kQRWallFunction; + value uniform 1000; } - - defaultFaces + defaultFaces { type empty; } } + // ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/ras/prism/0/mut b/tutorials/compressible/sonicFoam/ras/prism/0/mut new file mode 100644 index 0000000000..e7ebcbc993 --- /dev/null +++ b/tutorials/compressible/sonicFoam/ras/prism/0/mut @@ -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; + } +} + + +// ************************************************************************* // diff --git a/tutorials/compressible/sonicFoam/ras/prism/constant/polyMesh/boundary b/tutorials/compressible/sonicFoam/ras/prism/constant/polyMesh/boundary index c8440081ea..635f185a35 100644 --- a/tutorials/compressible/sonicFoam/ras/prism/constant/polyMesh/boundary +++ b/tutorials/compressible/sonicFoam/ras/prism/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/compressible/sonicLiquidFoam/decompressionTank/constant/polyMesh/boundary b/tutorials/compressible/sonicLiquidFoam/decompressionTank/constant/polyMesh/boundary index d2479db212..add55d69d6 100644 --- a/tutorials/compressible/sonicLiquidFoam/decompressionTank/constant/polyMesh/boundary +++ b/tutorials/compressible/sonicLiquidFoam/decompressionTank/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/discreteMethods/dsmcFoam/freeSpacePeriodic/0/uniform/lagrangian/dsmc/particleProperties b/tutorials/discreteMethods/dsmcFoam/freeSpacePeriodic/0/uniform/lagrangian/dsmc/particleProperties new file mode 100644 index 0000000000..461aa98233 --- /dev/null +++ b/tutorials/discreteMethods/dsmcFoam/freeSpacePeriodic/0/uniform/lagrangian/dsmc/particleProperties @@ -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; +} + + +// ************************************************************************* // diff --git a/tutorials/discreteMethods/dsmcFoam/freeSpaceStream/0/uniform/lagrangian/dsmc/particleProperties b/tutorials/discreteMethods/dsmcFoam/freeSpaceStream/0/uniform/lagrangian/dsmc/particleProperties new file mode 100644 index 0000000000..461aa98233 --- /dev/null +++ b/tutorials/discreteMethods/dsmcFoam/freeSpaceStream/0/uniform/lagrangian/dsmc/particleProperties @@ -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; +} + + +// ************************************************************************* // diff --git a/tutorials/electromagnetics/electrostaticFoam/chargedWire/constant/polyMesh/boundary b/tutorials/electromagnetics/electrostaticFoam/chargedWire/constant/polyMesh/boundary index 0ccf019b6d..19dcc8f12a 100644 --- a/tutorials/electromagnetics/electrostaticFoam/chargedWire/constant/polyMesh/boundary +++ b/tutorials/electromagnetics/electrostaticFoam/chargedWire/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/combustion/XiFoam/les/pitzDaily/0/ft b/tutorials/electromagnetics/mhdFoam/hartmann/0/Ux similarity index 64% rename from tutorials/combustion/XiFoam/les/pitzDaily/0/ft rename to tutorials/electromagnetics/mhdFoam/hartmann/0/Ux index 886886dd1a..710f0df1b2 100644 --- a/tutorials/combustion/XiFoam/les/pitzDaily/0/ft +++ b/tutorials/electromagnetics/mhdFoam/hartmann/0/Ux @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,43 +10,42 @@ FoamFile version 2.0; format ascii; 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; boundaryField { - inlet + inlet { - type fixedValue; + type calculated; + value uniform 1; + } + outlet + { + type calculated; value uniform 0; } - - outlet + lowerWall { - type inletOutlet; - inletValue uniform 0; + type calculated; value uniform 0; } - - upperWall + upperWall { - type zeroGradient; + type calculated; + value uniform 0; } - - lowerWall - { - type zeroGradient; - } - - frontAndBack + frontAndBack { type empty; } } + // ************************************************************************* // diff --git a/tutorials/electromagnetics/mhdFoam/hartmann/0/Uy b/tutorials/electromagnetics/mhdFoam/hartmann/0/Uy new file mode 100644 index 0000000000..7154a1fe5f --- /dev/null +++ b/tutorials/electromagnetics/mhdFoam/hartmann/0/Uy @@ -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; + } +} + + +// ************************************************************************* // diff --git a/tutorials/electromagnetics/mhdFoam/hartmann/0/Uz b/tutorials/electromagnetics/mhdFoam/hartmann/0/Uz new file mode 100644 index 0000000000..fb4475364a --- /dev/null +++ b/tutorials/electromagnetics/mhdFoam/hartmann/0/Uz @@ -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; + } +} + + +// ************************************************************************* // diff --git a/tutorials/electromagnetics/mhdFoam/hartmann/constant/polyMesh/boundary b/tutorials/electromagnetics/mhdFoam/hartmann/constant/polyMesh/boundary index 6b2eb17562..77a03408cd 100644 --- a/tutorials/electromagnetics/mhdFoam/hartmann/constant/polyMesh/boundary +++ b/tutorials/electromagnetics/mhdFoam/hartmann/constant/polyMesh/boundary @@ -1,7 +1,7 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5-8cbffd16687e | +| \\ / O peration | Version: dev | | \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ diff --git a/tutorials/financial/financialFoam/europeanCall/constant/polyMesh/boundary b/tutorials/financial/financialFoam/europeanCall/constant/polyMesh/boundary index edc3f6e6e2..b2d00fdb82 100644 --- a/tutorials/financial/financialFoam/europeanCall/constant/polyMesh/boundary +++ b/tutorials/financial/financialFoam/europeanCall/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/polyMesh/boundary b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/polyMesh/boundary new file mode 100644 index 0000000000..e0608ea9d7 --- /dev/null +++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/polyMesh/boundary @@ -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; + } +) + +// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/epsilon.old b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/alphat similarity index 65% rename from tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/epsilon.old rename to tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/alphat index 23851291dc..a270cb2178 100644 --- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/epsilon.old +++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/alphat @@ -11,30 +11,35 @@ FoamFile format ascii; class volScalarField; 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 { + box + { + type compressible::alphatWallFunction; + value uniform 0; + } floor { - type compressible::epsilonWallFunction; - value uniform 0.01; + type compressible::alphatWallFunction; + value uniform 0; } ceiling { - type compressible::epsilonWallFunction; - value uniform 0.01; + type compressible::alphatWallFunction; + value uniform 0; } fixedWalls { - type compressible::epsilonWallFunction; - value uniform 0.01; + type compressible::alphatWallFunction; + value uniform 0; } } diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/epsilon b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/epsilon index d5e7b9cd02..312afc24a6 100644 --- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/epsilon +++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/epsilon @@ -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; boundaryField { - floor - { - type compressible::epsilonWallFunction; - value uniform 0; - } - - ceiling - { - type compressible::epsilonWallFunction; - value uniform 0; - } - - fixedWalls - { - type compressible::epsilonWallFunction; - value uniform 0; - } - box { 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; } } diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k index 5b206f8e4e..daee975209 100644 --- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k +++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/k @@ -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; boundaryField { - floor - { - type compressible::kQRWallFunction; - value uniform 0; - } - - ceiling - { - type compressible::kQRWallFunction; - value uniform 0; - } - - fixedWalls - { - type compressible::kQRWallFunction; - value uniform 0; - } - box { 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; } } diff --git a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/k.old b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/mut similarity index 69% rename from tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/k.old rename to tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/mut index 4ec7f08960..06d03ee778 100644 --- a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/k.old +++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/0/mut @@ -11,30 +11,35 @@ FoamFile format ascii; class volScalarField; 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 { + box + { + type mutWallFunction; + value uniform 0; + } floor { - type compressible::kQRWallFunction; - value uniform 0.1; + type mutWallFunction; + value uniform 0; } ceiling { - type compressible::kQRWallFunction; - value uniform 0.1; + type mutWallFunction; + value uniform 0; } fixedWalls { - type compressible::kQRWallFunction; - value uniform 0.1; + type mutWallFunction; + value uniform 0; } } diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/polyMesh/boundary b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/polyMesh/boundary index add6399d3f..ab64c00e28 100644 --- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/polyMesh/boundary +++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoom/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/polyMesh/boundary b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/polyMesh/boundary index ab64c00e28..47d2c42505 100644 --- a/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/polyMesh/boundary +++ b/tutorials/heatTransfer/buoyantSimpleRadiationFoam/hotRadiationRoomFvDOM/constant/polyMesh/boundary @@ -8,7 +8,7 @@ FoamFile { version 2.0; - format ascii; + format binary; class polyBoundaryMesh; location "constant/polyMesh"; object boundary; diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/K b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/K similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/K rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/K diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/T b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/T similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/T rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/T diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/U b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/U similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/U rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/U diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/alphat b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/alphat similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/alphat rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/alphat diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/cp b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/cp similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/cp rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/cp diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/epsilon b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/epsilon similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/epsilon rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/epsilon diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/k b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/k similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/k rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/k diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/p b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/p similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/p rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/p diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/0/rho b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/rho similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/0/rho rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/0/rho diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/Allclean b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/Allclean similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/Allclean rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/Allclean diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/Allrun b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/Allrun similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/Allrun rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/Allrun diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/RASProperties similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/RASProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/RASProperties diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/g similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/g rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/g diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/thermophysicalProperties similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/thermophysicalProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/thermophysicalProperties diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/turbulenceProperties similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/bottomAir/turbulenceProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/bottomAir/turbulenceProperties diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/polyMesh/blockMeshDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/polyMesh/blockMeshDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/polyMesh/blockMeshDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/polyMesh/blockMeshDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/polyMesh/boundary b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/polyMesh/boundary similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/polyMesh/boundary rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/polyMesh/boundary diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/regionProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/regionProperties similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/regionProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/regionProperties diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/RASProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/RASProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/RASProperties diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/g b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/g rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/g diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/thermophysicalProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/thermophysicalProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/thermophysicalProperties diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/turbulenceProperties b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/topAir/turbulenceProperties rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/topAir/turbulenceProperties diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/bottomAir.stl b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/bottomAir.stl similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/bottomAir.stl rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/bottomAir.stl diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/heater.stl b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/heater.stl similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/heater.stl rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/heater.stl diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/leftSolid.stl b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/leftSolid.stl similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/leftSolid.stl rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/leftSolid.stl diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/rightSolid.stl b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/rightSolid.stl similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/rightSolid.stl rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/rightSolid.stl diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/topAir.stl b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/topAir.stl similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/constant/triSurface/topAir.stl rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/constant/triSurface/topAir.stl diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/makeCellSets.setSet b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/makeCellSets.setSet similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/makeCellSets.setSet rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/makeCellSets.setSet diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/README b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/README similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/README rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/README diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/changeDictionaryDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/changeDictionaryDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/changeDictionaryDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/decomposeParDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/decomposeParDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/decomposeParDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSchemes diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSolution similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/bottomAir/fvSolution rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/bottomAir/fvSolution diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/controlDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/controlDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/controlDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/controlDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/decomposeParDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/decomposeParDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/decomposeParDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/fvSchemes similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/fvSchemes diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/fvSolution similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/fvSolution rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/fvSolution diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/changeDictionaryDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/changeDictionaryDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/changeDictionaryDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/decomposeParDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/decomposeParDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/decomposeParDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSchemes diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSolution similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/heater/fvSolution rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/heater/fvSolution diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/changeDictionaryDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/changeDictionaryDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/changeDictionaryDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/decomposeParDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/decomposeParDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/decomposeParDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSchemes diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSolution similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/leftSolid/fvSolution rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/leftSolid/fvSolution diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/changeDictionaryDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/changeDictionaryDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/changeDictionaryDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/decomposeParDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/decomposeParDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/decomposeParDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSchemes diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSolution similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/rightSolid/fvSolution rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/rightSolid/fvSolution diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/snappyHexMeshDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/snappyHexMeshDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/snappyHexMeshDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/snappyHexMeshDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/changeDictionaryDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/changeDictionaryDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/changeDictionaryDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/changeDictionaryDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/decomposeParDict b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/decomposeParDict similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/decomposeParDict rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/decomposeParDict diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/fvSchemes b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/fvSchemes rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSchemes diff --git a/tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/fvSolution b/tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution similarity index 100% rename from tutorials/mesh/snappyHexMesh/multiRegionMesh/system/topAir/fvSolution rename to tutorials/heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater/system/topAir/fvSolution diff --git a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/blockMeshDict b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/blockMeshDict index 0679f5ee9a..554df2afd6 100644 --- a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/blockMeshDict +++ b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/blockMeshDict @@ -15,7 +15,16 @@ FoamFile // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // General macros to create 2D/extruded-2D meshes -//define(calc, [esyscmd(echo $1 | bc | tr -d \\n)]) + + + + + + + + + + // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // @@ -23,33 +32,283 @@ convertToMeters 0.1; // Hub radius + // Impeller-tip radius + // Baffle-tip radius + // Tank radius + // MRF region radius + // Thickness of 2D slab + // Base z + // Top z + // Number of cells radially between hub and impeller tip + // Number of cells radially in each of the two regions between // impeller and baffle tips + // Number of cells radially between baffle tip and tank + // Number of cells azimuthally in each of the 8 blocks + // Number of cells in the thickness of the slab + // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // vertices @@ -161,7 +420,7 @@ vertices (0.707106781821139 0.707106780551956 0.1) // Vertex R7st = 95 ); -blocks +blocks ( // block0 hex (0 2 13 12 48 50 61 60) @@ -433,7 +692,7 @@ edges arc 94 84 (0.923879532683006 0.382683431950523 0.1) ); -patches +patches ( wall rotor ( diff --git a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/boundary b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/boundary index 301f1ff612..292f25b806 100644 --- a/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/boundary +++ b/tutorials/incompressible/MRFSimpleFoam/mixerVessel2D/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,39 +10,37 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 4 ( -rotor -{ - type wall; - nFaces 192; - startFace 5952; -} - -stator -{ - type wall; - nFaces 192; - startFace 6144; -} - -front -{ - type empty; - nFaces 3072; - startFace 6336; -} - -back -{ - type empty; - nFaces 3072; - startFace 9408; -} + rotor + { + type wall; + nFaces 192; + startFace 5952; + } + stator + { + type wall; + nFaces 192; + startFace 6144; + } + front + { + type empty; + nFaces 3072; + startFace 6336; + } + back + { + type empty; + nFaces 3072; + startFace 9408; + } ) // ************************************************************************* // diff --git a/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/polyMesh/boundary b/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/polyMesh/boundary index 5ee792177a..34af32827c 100644 --- a/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/polyMesh/boundary +++ b/tutorials/incompressible/boundaryFoam/boundaryLaunderSharma/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/polyMesh/boundary b/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/polyMesh/boundary index 5ee792177a..34af32827c 100644 --- a/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/polyMesh/boundary +++ b/tutorials/incompressible/boundaryFoam/boundaryWallFunctions/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/incompressible/channelFoam/channel395/constant/LESProperties b/tutorials/incompressible/channelFoam/channel395/constant/LESProperties index 8c32bfa67c..9bcc936fc3 100644 --- a/tutorials/incompressible/channelFoam/channel395/constant/LESProperties +++ b/tutorials/incompressible/channelFoam/channel395/constant/LESProperties @@ -17,8 +17,6 @@ FoamFile LESModel oneEqEddy; -turbulence on; - printCoeffs on; delta vanDriest; diff --git a/tutorials/incompressible/channelFoam/channel395/constant/polyMesh/boundary b/tutorials/incompressible/channelFoam/channel395/constant/polyMesh/boundary index fb95d69234..2f0b51717c 100644 --- a/tutorials/incompressible/channelFoam/channel395/constant/polyMesh/boundary +++ b/tutorials/incompressible/channelFoam/channel395/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/incompressible/icoFoam/cavity/constant/polyMesh/boundary b/tutorials/incompressible/icoFoam/cavity/constant/polyMesh/boundary index cc15fe93fc..61feadd974 100644 --- a/tutorials/incompressible/icoFoam/cavity/constant/polyMesh/boundary +++ b/tutorials/incompressible/icoFoam/cavity/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/incompressible/icoFoam/cavityClipped/constant/polyMesh/boundary b/tutorials/incompressible/icoFoam/cavityClipped/constant/polyMesh/boundary index 63b839343e..8c7162efda 100644 --- a/tutorials/incompressible/icoFoam/cavityClipped/constant/polyMesh/boundary +++ b/tutorials/incompressible/icoFoam/cavityClipped/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/incompressible/icoFoam/cavityGrade/constant/polyMesh/boundary b/tutorials/incompressible/icoFoam/cavityGrade/constant/polyMesh/boundary index cc15fe93fc..61feadd974 100644 --- a/tutorials/incompressible/icoFoam/cavityGrade/constant/polyMesh/boundary +++ b/tutorials/incompressible/icoFoam/cavityGrade/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/incompressible/icoFoam/elbow/constant/polyMesh/boundary b/tutorials/incompressible/icoFoam/elbow/constant/polyMesh/boundary index 0b3c204903..fbdbc176b3 100644 --- a/tutorials/incompressible/icoFoam/elbow/constant/polyMesh/boundary +++ b/tutorials/incompressible/icoFoam/elbow/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/incompressible/nonNewtonianIcoFoam/offsetCylinder/constant/polyMesh/boundary b/tutorials/incompressible/nonNewtonianIcoFoam/offsetCylinder/constant/polyMesh/boundary index 31f0f41f93..7766ed29e4 100644 --- a/tutorials/incompressible/nonNewtonianIcoFoam/offsetCylinder/constant/polyMesh/boundary +++ b/tutorials/incompressible/nonNewtonianIcoFoam/offsetCylinder/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,53 +10,49 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 6 ( -left -{ - type patch; - nFaces 35; - startFace 3485; -} - -right -{ - type patch; - nFaces 35; - startFace 3520; -} - -down -{ - type wall; - nFaces 40; - startFace 3555; -} - -up -{ - type wall; - nFaces 40; - startFace 3595; -} - -cylinder -{ - type wall; - nFaces 80; - startFace 3635; -} - -defaultFaces -{ - type empty; - nFaces 3600; - startFace 3715; -} + left + { + type patch; + nFaces 35; + startFace 3485; + } + right + { + type patch; + nFaces 35; + startFace 3520; + } + down + { + type wall; + nFaces 40; + startFace 3555; + } + up + { + type wall; + nFaces 40; + startFace 3595; + } + cylinder + { + type wall; + nFaces 80; + startFace 3635; + } + defaultFaces + { + type empty; + nFaces 3600; + startFace 3715; + } ) // ************************************************************************* // diff --git a/tutorials/incompressible/pimpleFoam/t-junction/constant/polyMesh/boundary b/tutorials/incompressible/pimpleFoam/t-junction/constant/polyMesh/boundary index a6e8b86643..62bc7f68e6 100644 --- a/tutorials/incompressible/pimpleFoam/t-junction/constant/polyMesh/boundary +++ b/tutorials/incompressible/pimpleFoam/t-junction/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties b/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties index 0d948b7ff1..034085751a 100644 --- a/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties +++ b/tutorials/incompressible/pisoFoam/les/pitzDaily/constant/LESProperties @@ -15,8 +15,6 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -turbulence on; - LESModel oneEqEddy; delta cubeRootVol; diff --git a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties index 0d948b7ff1..034085751a 100644 --- a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties +++ b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/LESProperties @@ -15,8 +15,6 @@ FoamFile } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -turbulence on; - LESModel oneEqEddy; delta cubeRootVol; diff --git a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary index 0b56bb9f5e..fb820c3f43 100644 --- a/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary +++ b/tutorials/incompressible/pisoFoam/les/pitzDailyDirectMapped/constant/polyMesh/boundary @@ -1,7 +1,7 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | +| \\ / O peration | Version: dev | | \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ @@ -24,6 +24,7 @@ inlet nFaces 30; startFace 27238; sampleMode nearestCell; + sampleRegion region0; samplePatch none; offset ( 0.0495 0 0 ); } diff --git a/tutorials/incompressible/pisoFoam/ras/cavity/constant/polyMesh/boundary b/tutorials/incompressible/pisoFoam/ras/cavity/constant/polyMesh/boundary index d68c9a7036..61feadd974 100644 --- a/tutorials/incompressible/pisoFoam/ras/cavity/constant/polyMesh/boundary +++ b/tutorials/incompressible/pisoFoam/ras/cavity/constant/polyMesh/boundary @@ -1,7 +1,7 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | +| \\ / O peration | Version: dev | | \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ diff --git a/tutorials/incompressible/simpleFoam/airFoil2D/Allclean b/tutorials/incompressible/simpleFoam/airFoil2D/Allclean index a657f303ba..f73c44df8a 100755 --- a/tutorials/incompressible/simpleFoam/airFoil2D/Allclean +++ b/tutorials/incompressible/simpleFoam/airFoil2D/Allclean @@ -3,3 +3,4 @@ # Clean time folders only rm -rf *[1-9]* +rm log.* diff --git a/tutorials/incompressible/simpleFoam/motorBike/constant/polyMesh/boundary b/tutorials/incompressible/simpleFoam/motorBike/constant/polyMesh/boundary index 7a2e890684..b79c6ad432 100644 --- a/tutorials/incompressible/simpleFoam/motorBike/constant/polyMesh/boundary +++ b/tutorials/incompressible/simpleFoam/motorBike/constant/polyMesh/boundary @@ -21,433 +21,433 @@ FoamFile { type patch; nFaces 320; - startFace 955219; + startFace 1016586; } inlet { type patch; nFaces 64; - startFace 955539; + startFace 1016906; } outlet { type patch; nFaces 64; - startFace 955603; + startFace 1016970; } lowerWall { type wall; nFaces 5330; - startFace 955667; + startFace 1017034; } upperWall { type patch; nFaces 160; - startFace 960997; + startFace 1022364; } motorBike_frt-fairing:001%1 { type wall; - nFaces 9726; - startFace 961157; + nFaces 6626; + startFace 1022524; } motorBike_windshield:002%2 { type wall; - nFaces 86; - startFace 970883; + nFaces 50; + startFace 1029150; } motorBike_rr-wh-rim:005%5 { type wall; - nFaces 186; - startFace 970969; + nFaces 181; + startFace 1029200; } motorBike_rr-wh-rim:010%10 { type wall; - nFaces 355; - startFace 971155; + nFaces 340; + startFace 1029381; } motorBike_fr-wh-rim:011%11 { type wall; - nFaces 594; - startFace 971510; + nFaces 474; + startFace 1029721; } motorBike_fr-wh-brake-disk:012%12 { type wall; - nFaces 55; - startFace 972104; + nFaces 54; + startFace 1030195; } motorBike_frame:016-shadow%13 { type wall; - nFaces 163; - startFace 972159; + nFaces 131; + startFace 1030249; } motorBike_rear-susp:014%14 { type wall; - nFaces 1300; - startFace 972322; + nFaces 1073; + startFace 1030380; } motorBike_rear-susp:014-shadow%15 { type wall; - nFaces 166; - startFace 973622; + nFaces 159; + startFace 1031453; } motorBike_frame:016%16 { type wall; - nFaces 21; - startFace 973788; + nFaces 20; + startFace 1031612; } motorBike_rr-wh-rim:005-shadow%17 { type wall; nFaces 25; - startFace 973809; + startFace 1031632; } motorBike_rr-wh-chain-hub:022%22 { type wall; - nFaces 161; - startFace 973834; + nFaces 141; + startFace 1031657; } motorBike_rearseat%24 { type wall; - nFaces 543; - startFace 973995; + nFaces 432; + startFace 1031798; } motorBike_frt-fairing%25 { type wall; - nFaces 927; - startFace 974538; + nFaces 626; + startFace 1032230; } motorBike_windshield%26 { type wall; - nFaces 821; - startFace 975465; + nFaces 428; + startFace 1032856; } motorBike_headlights%27 { type wall; - nFaces 280; - startFace 976286; + nFaces 161; + startFace 1033284; } motorBike_driversseat%28 { type wall; - nFaces 457; - startFace 976566; + nFaces 367; + startFace 1033445; } motorBike_rear-body%29 { type wall; - nFaces 3081; - startFace 977023; + nFaces 2076; + startFace 1033812; } motorBike_fuel-tank%30 { type wall; - nFaces 1512; - startFace 980104; + nFaces 912; + startFace 1035888; } motorBike_exhaust%31 { type wall; - nFaces 3516; - startFace 981616; + nFaces 2391; + startFace 1036800; } motorBike_rr-wh-rim%32 { type wall; - nFaces 2128; - startFace 985132; + nFaces 1430; + startFace 1039191; } motorBike_fr-mud-guard%33 { type wall; - nFaces 1096; - startFace 987260; + nFaces 767; + startFace 1040621; } motorBike_fr-wh-rim%34 { type wall; - nFaces 954; - startFace 988356; + nFaces 592; + startFace 1041388; } motorBike_fr-wh-brake-disk%35 { type wall; nFaces 533; - startFace 989310; + startFace 1041980; } motorBike_fr-brake-caliper%36 { type wall; - nFaces 199; - startFace 989843; + nFaces 164; + startFace 1042513; } motorBike_fr-wh-tyre%37 { type wall; - nFaces 1855; - startFace 990042; + nFaces 1118; + startFace 1042677; } motorBike_hbars%38 { type wall; - nFaces 745; - startFace 991897; + nFaces 535; + startFace 1043795; } motorBike_fr-forks%39 { type wall; - nFaces 1637; - startFace 992642; + nFaces 1144; + startFace 1044330; } motorBike_chain%40 { type wall; - nFaces 484; - startFace 994279; + nFaces 474; + startFace 1045474; } motorBike_rr-wh-tyre%41 { type wall; - nFaces 3022; - startFace 994763; + nFaces 1785; + startFace 1045948; } motorBike_square-dial%42 { type wall; - nFaces 9; - startFace 997785; + nFaces 6; + startFace 1047733; } motorBike_round-dial%43 { type wall; - nFaces 24; - startFace 997794; + nFaces 18; + startFace 1047739; } motorBike_dial-holder%44 { type wall; - nFaces 120; - startFace 997818; + nFaces 87; + startFace 1047757; } motorBike_rear-susp%45 { type wall; - nFaces 2050; - startFace 997938; + nFaces 1787; + startFace 1047844; } motorBike_rear-brake-lights%46 { type wall; - nFaces 75; - startFace 999988; + nFaces 54; + startFace 1049631; } motorBike_rear-light-bracket%47 { type wall; - nFaces 226; - startFace 1000063; + nFaces 163; + startFace 1049685; } motorBike_frame%48 { type wall; - nFaces 2849; - startFace 1000289; + nFaces 2040; + startFace 1049848; } motorBike_rear-mud-guard%49 { type wall; - nFaces 1177; - startFace 1003138; + nFaces 804; + startFace 1051888; } motorBike_rear-susp-spring-damp%50 { type wall; - nFaces 138; - startFace 1004315; + nFaces 125; + startFace 1052692; } motorBike_fairing-inner-plate%51 { type wall; - nFaces 551; - startFace 1004453; + nFaces 446; + startFace 1052817; } motorBike_clutch-housing%52 { type wall; - nFaces 1199; - startFace 1005004; + nFaces 966; + startFace 1053263; } motorBike_radiator%53 { type wall; - nFaces 51; - startFace 1006203; + nFaces 48; + startFace 1054229; } motorBike_water-pipe%54 { type wall; - nFaces 112; - startFace 1006254; + nFaces 103; + startFace 1054277; } motorBike_water-pump%55 { type wall; - nFaces 96; - startFace 1006366; + nFaces 74; + startFace 1054380; } motorBike_engine%56 { type wall; - nFaces 2963; - startFace 1006462; + nFaces 2384; + startFace 1054454; } motorBike_rear-shock-link%57 { type wall; - nFaces 33; - startFace 1009425; + nFaces 29; + startFace 1056838; } motorBike_rear-brake-fluid-pot-bracket%58 { type wall; - nFaces 63; - startFace 1009458; + nFaces 59; + startFace 1056867; } motorBike_rear-brake-fluid-pot%59 { type wall; - nFaces 59; - startFace 1009521; + nFaces 53; + startFace 1056926; } motorBike_footpeg%60 { type wall; - nFaces 103; - startFace 1009580; + nFaces 87; + startFace 1056979; } motorBike_rr-wh-chain-hub%61 { type wall; - nFaces 160; - startFace 1009683; + nFaces 145; + startFace 1057066; } motorBike_rear-brake-caliper%62 { type wall; - nFaces 158; - startFace 1009843; + nFaces 142; + startFace 1057211; } motorBike_rider-helmet%65 { type wall; - nFaces 964; - startFace 1010001; + nFaces 583; + startFace 1057353; } motorBike_rider-visor%66 { type wall; - nFaces 170; - startFace 1010965; + nFaces 95; + startFace 1057936; } motorBike_rider-boots%67 { type wall; - nFaces 1657; - startFace 1011135; + nFaces 1025; + startFace 1058031; } motorBike_rider-gloves%68 { type wall; - nFaces 436; - startFace 1012792; + nFaces 320; + startFace 1059056; } motorBike_rider-body%69 { type wall; - nFaces 7207; - startFace 1013228; + nFaces 4555; + startFace 1059376; } motorBike_frame:0%70 { type wall; - nFaces 52; - startFace 1020435; + nFaces 37; + startFace 1063931; } motorBike_frt-fairing:001-shadow%74 { type wall; - nFaces 1340; - startFace 1020487; + nFaces 1274; + startFace 1063968; } motorBike_windshield-shadow%75 { type wall; - nFaces 111; - startFace 1021827; + nFaces 101; + startFace 1065242; } motorBike_fr-mud-guard-shadow%81 { type wall; - nFaces 135; - startFace 1021938; + nFaces 129; + startFace 1065343; } motorBike_fr-wh-brake-disk-shadow%83 { type wall; nFaces 77; - startFace 1022073; + startFace 1065472; } motorBike_rear-mud-guard-shadow%84 { type wall; - nFaces 143; - startFace 1022150; + nFaces 138; + startFace 1065549; } motorBike_rear-susp-spring-damp-shadow%85 { type wall; nFaces 15; - startFace 1022293; + startFace 1065687; } motorBike_radiator-shadow%86 { type wall; nFaces 12; - startFace 1022308; + startFace 1065702; } motorBike_rear-shock-link-shadow%87 { type wall; nFaces 7; - startFace 1022320; + startFace 1065714; } motorBike_rear-brake-fluid-pot-bracket-shadow%88 { type wall; nFaces 6; - startFace 1022327; + startFace 1065721; } motorBike_rr-wh-chain-hub-shadow%89 { type wall; nFaces 24; - startFace 1022333; + startFace 1065727; } ) diff --git a/tutorials/incompressible/simpleFoam/pitzDaily/constant/polyMesh/boundary b/tutorials/incompressible/simpleFoam/pitzDaily/constant/polyMesh/boundary new file mode 100644 index 0000000000..313dcceba1 --- /dev/null +++ b/tutorials/incompressible/simpleFoam/pitzDaily/constant/polyMesh/boundary @@ -0,0 +1,52 @@ +/*--------------------------------*- 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; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +5 +( + inlet + { + type patch; + nFaces 30; + startFace 24170; + } + outlet + { + type patch; + nFaces 57; + startFace 24200; + } + upperWall + { + type wall; + nFaces 223; + startFace 24257; + } + lowerWall + { + type wall; + nFaces 250; + startFace 24480; + } + frontAndBack + { + type empty; + nFaces 24450; + startFace 24730; + } +) + +// ************************************************************************* // diff --git a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/polyMesh/boundary b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/polyMesh/boundary index 8eb7d98937..313dcceba1 100644 --- a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/polyMesh/boundary +++ b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,46 +10,43 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 5 ( -inlet -{ - type patch; - nFaces 30; - startFace 24170; -} - -outlet -{ - type patch; - nFaces 57; - startFace 24200; -} - -upperWall -{ - type wall; - nFaces 223; - startFace 24257; -} - -lowerWall -{ - type wall; - nFaces 250; - startFace 24480; -} - -frontAndBack -{ - type empty; - nFaces 24450; - startFace 24730; -} + inlet + { + type patch; + nFaces 30; + startFace 24170; + } + outlet + { + type patch; + nFaces 57; + startFace 24200; + } + upperWall + { + type wall; + nFaces 223; + startFace 24257; + } + lowerWall + { + type wall; + nFaces 250; + startFace 24480; + } + frontAndBack + { + type empty; + nFaces 24450; + startFace 24730; + } ) // ************************************************************************* // diff --git a/tutorials/incompressible/simpleSRFFoam/mixer/constant/polyMesh/boundary b/tutorials/incompressible/simpleSRFFoam/mixer/constant/polyMesh/boundary new file mode 100644 index 0000000000..e752d70159 --- /dev/null +++ b/tutorials/incompressible/simpleSRFFoam/mixer/constant/polyMesh/boundary @@ -0,0 +1,53 @@ +/*--------------------------------*- 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; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +5 +( + inlet + { + type patch; + nFaces 840; + startFace 96680; + } + outlet + { + type patch; + nFaces 840; + startFace 97520; + } + innerWall + { + type wall; + nFaces 2480; + startFace 98360; + } + outerWall + { + type wall; + nFaces 880; + startFace 100840; + } + cyclic + { + type cyclic; + nFaces 3200; + startFace 101720; + featureCos 0.9; + } +) + +// ************************************************************************* // diff --git a/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/alphat b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/alphat new file mode 100644 index 0000000000..8ceda71797 --- /dev/null +++ b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/alphat @@ -0,0 +1,50 @@ +/*--------------------------------*- 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 +{ + top + { + type compressible::alphatWallFunction; + value uniform 0; + } + bottom + { + type compressible::alphatWallFunction; + value uniform 0; + } + walls + { + type compressible::alphatWallFunction; + value uniform 0; + } + symmetry + { + type symmetryPlane; + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/k.old b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/mut similarity index 65% rename from tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/k.old rename to tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/mut index 4ec7f08960..c2fd24e8ef 100644 --- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/hotRoom/0/k.old +++ b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/0/mut @@ -11,30 +11,38 @@ FoamFile format ascii; class volScalarField; 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 { - floor + top { - type compressible::kQRWallFunction; - value uniform 0.1; + type mutWallFunction; + value uniform 0; } - ceiling + bottom { - type compressible::kQRWallFunction; - value uniform 0.1; + type mutWallFunction; + value uniform 0; } - fixedWalls + walls { - type compressible::kQRWallFunction; - value uniform 0.1; + type mutWallFunction; + value uniform 0; + } + symmetry + { + type symmetryPlane; + } + frontAndBack + { + type empty; } } diff --git a/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/constant/polyMesh/boundary b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/constant/polyMesh/boundary new file mode 100644 index 0000000000..b130d7bc0a --- /dev/null +++ b/tutorials/lagrangian/coalChemistryFoam/simplifiedSiwek/constant/polyMesh/boundary @@ -0,0 +1,52 @@ +/*--------------------------------*- 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; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +5 +( + top + { + type wall; + nFaces 5; + startFace 4855; + } + bottom + { + type wall; + nFaces 45; + startFace 4860; + } + walls + { + type wall; + nFaces 140; + startFace 4905; + } + symmetry + { + type symmetryPlane; + nFaces 100; + startFace 5045; + } + frontAndBack + { + type empty; + nFaces 5000; + startFace 5145; + } +) + +// ************************************************************************* // diff --git a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/Allclean b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/Allclean index 9ded4bdec6..cb015f101f 100755 --- a/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/Allclean +++ b/tutorials/lagrangian/porousExplicitSourceReactingParcelFoam/filter/Allclean @@ -1,16 +1,12 @@ #!/bin/sh -set -x -# remove old cell sets -rm -rf constant/polyMesh/sets -foamClearPolyMesh +# Source tutorial clean functions +. $WM_PROJECT_DIR/bin/tools/CleanFunctions -# remove old time folders -rm -rf 0 *[1-9]* +cleanCase -# remove old log files -rm -f log* +# remove 0 directory +rm -rf 0 # copy 0.org to 0 cp -r 0.org 0 - diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/0/alpha1 b/tutorials/lagrangian/reactingParcelFoam/evaporationTest/constant/polyMesh/boundary similarity index 64% rename from tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/0/alpha1 rename to tutorials/lagrangian/reactingParcelFoam/evaporationTest/constant/polyMesh/boundary index 8e28c332b7..52fb40b02f 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/0/alpha1 +++ b/tutorials/lagrangian/reactingParcelFoam/evaporationTest/constant/polyMesh/boundary @@ -1,37 +1,34 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile { version 2.0; format ascii; - class volScalarField; - object alpha1; + class polyBoundaryMesh; + location "constant/polyMesh"; + object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [0 0 0 0 0 0 0]; - -internalField uniform 0; - -boundaryField -{ - front - { - type empty; - } - back - { - type empty; - } +2 +( walls { - type zeroGradient; + type wall; + nFaces 80; + startFace 760; } -} + frontAndBack + { + type empty; + nFaces 800; + startFace 840; + } +) // ************************************************************************* // diff --git a/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/alphat b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/alphat new file mode 100644 index 0000000000..8ceda71797 --- /dev/null +++ b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/alphat @@ -0,0 +1,50 @@ +/*--------------------------------*- 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 +{ + top + { + type compressible::alphatWallFunction; + value uniform 0; + } + bottom + { + type compressible::alphatWallFunction; + value uniform 0; + } + walls + { + type compressible::alphatWallFunction; + value uniform 0; + } + symmetry + { + type symmetryPlane; + } + frontAndBack + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/epsilon.old b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/mut similarity index 65% rename from tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/epsilon.old rename to tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/mut index 23851291dc..c2fd24e8ef 100644 --- a/tutorials/heatTransfer/buoyantBoussinesqPisoFoam/hotRoom/0/epsilon.old +++ b/tutorials/lagrangian/rhoPisoTwinParcelFoam/simplifiedSiwek/0/mut @@ -11,30 +11,38 @@ FoamFile format ascii; class volScalarField; location "0"; - object epsilon; + object mut; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -dimensions [0 2 -3 0 0 0 0]; +dimensions [1 -1 -1 0 0 0 0]; -internalField uniform 0.01; +internalField uniform 0; boundaryField { - floor + top { - type compressible::epsilonWallFunction; - value uniform 0.01; + type mutWallFunction; + value uniform 0; } - ceiling + bottom { - type compressible::epsilonWallFunction; - value uniform 0.01; + type mutWallFunction; + value uniform 0; } - fixedWalls + walls { - type compressible::epsilonWallFunction; - value uniform 0.01; + type mutWallFunction; + value uniform 0; + } + symmetry + { + type symmetryPlane; + } + frontAndBack + { + type empty; } } diff --git a/tutorials/mesh/snappyHexMesh/snappyMultiRegionHeater b/tutorials/mesh/snappyHexMesh/snappyMultiRegionHeater new file mode 120000 index 0000000000..4d5b442c46 --- /dev/null +++ b/tutorials/mesh/snappyHexMesh/snappyMultiRegionHeater @@ -0,0 +1 @@ +../../heatTransfer/chtMultiRegionFoam/snappyMultiRegionHeater \ No newline at end of file diff --git a/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/polyMesh/boundary b/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/polyMesh/boundary index 70c4c3d9af..56e0a545c1 100644 --- a/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/polyMesh/boundary +++ b/tutorials/multiphase/bubbleFoam/bubbleColumn/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties b/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties index b16fea4ab2..583bb94896 100644 --- a/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties +++ b/tutorials/multiphase/cavitatingFoam/les/throttle/constant/LESProperties @@ -17,8 +17,6 @@ FoamFile LESModel oneEqEddy; -turbulence on; - delta smooth; laminarCoeffs diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle/constant/polyMesh/boundary b/tutorials/multiphase/cavitatingFoam/les/throttle/constant/polyMesh/boundary index b2c07faf58..f401f8d162 100644 --- a/tutorials/multiphase/cavitatingFoam/les/throttle/constant/polyMesh/boundary +++ b/tutorials/multiphase/cavitatingFoam/les/throttle/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -21,25 +21,25 @@ FoamFile { type patch; nFaces 51; - startFace 15151; + startFace 57362; } outlet { type patch; nFaces 51; - startFace 15202; + startFace 57413; } walls { type wall; - nFaces 436; - startFace 15253; + nFaces 836; + startFace 57464; } frontBack { type empty; - nFaces 15420; - startFace 15689; + nFaces 57540; + startFace 58300; } ) diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties b/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties index b16fea4ab2..583bb94896 100644 --- a/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties +++ b/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/LESProperties @@ -17,8 +17,6 @@ FoamFile LESModel oneEqEddy; -turbulence on; - delta smooth; laminarCoeffs diff --git a/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/polyMesh/boundary b/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/polyMesh/boundary index adffe02dd4..e48eb3773b 100644 --- a/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/polyMesh/boundary +++ b/tutorials/multiphase/cavitatingFoam/les/throttle3D/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -21,25 +21,25 @@ FoamFile { type patch; nFaces 510; - startFace 220900; + startFace 4413730; } outlet { type patch; nFaces 510; - startFace 221410; + startFace 4414240; } walls { type wall; - nFaces 4360; - startFace 221920; + nFaces 37840; + startFace 4414750; } frontBack { type wall; - nFaces 15420; - startFace 226280; + nFaces 57540; + startFace 4452590; } ) diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/0/alpha1.gz b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/0/alpha1.gz new file mode 100644 index 0000000000..d976dd8e94 Binary files /dev/null and b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/0/alpha1.gz differ diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/0/p.gz b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/0/p.gz new file mode 100644 index 0000000000..62a7129895 Binary files /dev/null and b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/0/p.gz differ diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties index dd76a64b43..14b6ce249d 100644 --- a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties +++ b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/LESProperties @@ -17,8 +17,6 @@ FoamFile LESModel laminar; -turbulence off; - delta cubeRootVol; laminarCoeffs diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/polyMesh/boundary b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/polyMesh/boundary index 52529b0c3d..9eb64e8637 100644 --- a/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/polyMesh/boundary +++ b/tutorials/multiphase/compressibleInterFoam/les/depthCharge2D/constant/polyMesh/boundary @@ -1,9 +1,9 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5-09ca1eb6b56f | -| \\ / A nd | | -| \\/ M anipulation | www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile { diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties b/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties index dd76a64b43..14b6ce249d 100644 --- a/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties +++ b/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/LESProperties @@ -17,8 +17,6 @@ FoamFile LESModel laminar; -turbulence off; - delta cubeRootVol; laminarCoeffs diff --git a/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/polyMesh/boundary b/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/polyMesh/boundary index f3c84ef8fb..b16c01a16f 100644 --- a/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/polyMesh/boundary +++ b/tutorials/multiphase/compressibleInterFoam/les/depthCharge3D/constant/polyMesh/boundary @@ -1,9 +1,9 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5-09ca1eb6b56f | -| \\ / A nd | | -| \\/ M anipulation | www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | +| \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile { diff --git a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary index 924d99d937..8122fa3f3a 100644 --- a/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary +++ b/tutorials/multiphase/interDyMFoam/ras/damBreakWithObstacle/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/blockMeshDict b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/blockMeshDict index c7d3ee2dcd..4a938bd66e 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/blockMeshDict +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/blockMeshDict @@ -15,9 +15,7 @@ FoamFile // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // General m4 macros - - - + diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/boundary b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/boundary index 53b37c41f6..067ff53cc9 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/boundary +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank2D/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/blockMeshDict b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/blockMeshDict index 98820d1a00..da310caafc 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/blockMeshDict +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/blockMeshDict @@ -15,9 +15,7 @@ FoamFile // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // General m4 macros - - - + diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/boundary b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/boundary index 31c74e19c2..20d992ff42 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/boundary +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/blockMeshDict b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/blockMeshDict index 98820d1a00..da310caafc 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/blockMeshDict +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/blockMeshDict @@ -15,9 +15,7 @@ FoamFile // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // General m4 macros - - - + diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/boundary b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/boundary index 31c74e19c2..20d992ff42 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/boundary +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D3DoF/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/blockMeshDict b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/blockMeshDict index 98820d1a00..da310caafc 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/blockMeshDict +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/blockMeshDict @@ -15,9 +15,7 @@ FoamFile // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // General m4 macros - - - + diff --git a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/boundary b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/boundary index 31c74e19c2..20d992ff42 100644 --- a/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/boundary +++ b/tutorials/multiphase/interDyMFoam/ras/sloshingTank3D6DoF/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties b/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties index 1d34e2477f..c4072e231d 100644 --- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties +++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/LESProperties @@ -17,8 +17,6 @@ FoamFile LESModel oneEqEddy; -turbulence on; - delta smooth; printCoeffs on; diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/system/cellSetDict b/tutorials/multiphase/interFoam/les/nozzleFlow2D/system/cellSetDict index cc4838bb42..e5e1a3c5c9 100644 --- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/system/cellSetDict +++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/system/cellSetDict @@ -11,7 +11,7 @@ FoamFile format ascii; class dictionary; location "system"; - object cellSetDict; + object cellSetDict.2; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/multiphase/interFoam/ras/damBreak/0/nut b/tutorials/multiphase/interFoam/ras/damBreak/0/nut new file mode 100644 index 0000000000..3d75dba791 --- /dev/null +++ b/tutorials/multiphase/interFoam/ras/damBreak/0/nut @@ -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 nut; +} +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +dimensions [0 2 -1 0 0 0 0]; + +internalField uniform 0; + +boundaryField +{ + leftWall + { + type nutWallFunction; + value uniform 0; + } + rightWall + { + type nutWallFunction; + value uniform 0; + } + lowerWall + { + type nutWallFunction; + value uniform 0; + } + atmosphere + { + type calculated; + value uniform 0; + } + defaultFaces + { + type empty; + } +} + + +// ************************************************************************* // diff --git a/tutorials/multiphase/interFoam/ras/damBreak/constant/polyMesh/boundary b/tutorials/multiphase/interFoam/ras/damBreak/constant/polyMesh/boundary index ef32a0cb80..41c06d5f3f 100644 --- a/tutorials/multiphase/interFoam/ras/damBreak/constant/polyMesh/boundary +++ b/tutorials/multiphase/interFoam/ras/damBreak/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,46 +10,43 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 5 ( -leftWall -{ - type wall; - nFaces 50; - startFace 4432; -} - -rightWall -{ - type wall; - nFaces 50; - startFace 4482; -} - -lowerWall -{ - type wall; - nFaces 62; - startFace 4532; -} - -atmosphere -{ - type patch; - nFaces 46; - startFace 4594; -} - -defaultFaces -{ - type empty; - nFaces 4536; - startFace 4640; -} + leftWall + { + type wall; + nFaces 50; + startFace 4432; + } + rightWall + { + type wall; + nFaces 50; + startFace 4482; + } + lowerWall + { + type wall; + nFaces 62; + startFace 4532; + } + atmosphere + { + type patch; + nFaces 46; + startFace 4594; + } + defaultFaces + { + type empty; + nFaces 4536; + startFace 4640; + } ) // ************************************************************************* // diff --git a/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/0/alphas b/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/0/alphas index 4d7076770a..a0f116ae89 100644 --- a/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/0/alphas +++ b/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/0/alphas @@ -1,7 +1,7 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | +| \\ / O peration | Version: dev | | \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ diff --git a/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/constant/polyMesh/boundary b/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/constant/polyMesh/boundary index ef32a0cb80..41c06d5f3f 100644 --- a/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/constant/polyMesh/boundary +++ b/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phase/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,46 +10,43 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 5 ( -leftWall -{ - type wall; - nFaces 50; - startFace 4432; -} - -rightWall -{ - type wall; - nFaces 50; - startFace 4482; -} - -lowerWall -{ - type wall; - nFaces 62; - startFace 4532; -} - -atmosphere -{ - type patch; - nFaces 46; - startFace 4594; -} - -defaultFaces -{ - type empty; - nFaces 4536; - startFace 4640; -} + leftWall + { + type wall; + nFaces 50; + startFace 4432; + } + rightWall + { + type wall; + nFaces 50; + startFace 4482; + } + lowerWall + { + type wall; + nFaces 62; + startFace 4532; + } + atmosphere + { + type patch; + nFaces 46; + startFace 4594; + } + defaultFaces + { + type empty; + nFaces 4536; + startFace 4640; + } ) // ************************************************************************* // diff --git a/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phaseFine/0/alphas b/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phaseFine/0/alphas index 99b42c75e4..4184b5fb20 100644 --- a/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phaseFine/0/alphas +++ b/tutorials/multiphase/multiphaseInterFoam/laminar/damBreak4phaseFine/0/alphas @@ -1,7 +1,7 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | +| \\ / O peration | Version: dev | | \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ diff --git a/tutorials/multiphase/settlingFoam/ras/dahl/constant/polyMesh/boundary b/tutorials/multiphase/settlingFoam/ras/dahl/constant/polyMesh/boundary index 430ad36dbf..5723f355b5 100644 --- a/tutorials/multiphase/settlingFoam/ras/dahl/constant/polyMesh/boundary +++ b/tutorials/multiphase/settlingFoam/ras/dahl/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,53 +10,49 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 6 ( -inlet -{ - type patch; - nFaces 40; - startFace 15760; -} - -outlet -{ - type patch; - nFaces 4; - startFace 15800; -} - -bottomWall -{ - type patch; - nFaces 200; - startFace 15804; -} - -endWall -{ - type wall; - nFaces 36; - startFace 16004; -} - -top -{ - type symmetryPlane; - nFaces 200; - startFace 16040; -} - -frontAndBack -{ - type empty; - nFaces 16000; - startFace 16240; -} + inlet + { + type patch; + nFaces 40; + startFace 15760; + } + outlet + { + type patch; + nFaces 4; + startFace 15800; + } + bottomWall + { + type patch; + nFaces 200; + startFace 15804; + } + endWall + { + type wall; + nFaces 36; + startFace 16004; + } + top + { + type symmetryPlane; + nFaces 200; + startFace 16040; + } + frontAndBack + { + type empty; + nFaces 16000; + startFace 16240; + } ) // ************************************************************************* // diff --git a/tutorials/multiphase/settlingFoam/ras/tank3D/Allclean b/tutorials/multiphase/settlingFoam/ras/tank3D/Allclean index a657f303ba..f73c44df8a 100755 --- a/tutorials/multiphase/settlingFoam/ras/tank3D/Allclean +++ b/tutorials/multiphase/settlingFoam/ras/tank3D/Allclean @@ -3,3 +3,4 @@ # Clean time folders only rm -rf *[1-9]* +rm log.* diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/polyMesh/boundary b/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/polyMesh/boundary index 3ffe962074..14035ec47a 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/polyMesh/boundary +++ b/tutorials/multiphase/twoPhaseEulerFoam/bed/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,6 +10,7 @@ FoamFile version 2.0; format binary; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/polyMesh/boundary b/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/polyMesh/boundary index a861e9875c..56005a65f5 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/polyMesh/boundary +++ b/tutorials/multiphase/twoPhaseEulerFoam/bed2/constant/polyMesh/boundary @@ -1,7 +1,7 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5-8cbffd16687e | +| \\ / O peration | Version: dev | | \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ diff --git a/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/polyMesh/boundary b/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/polyMesh/boundary index cdffeb226b..56e0a545c1 100644 --- a/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/polyMesh/boundary +++ b/tutorials/multiphase/twoPhaseEulerFoam/bubbleColumn/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,39 +10,37 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 4 ( -inlet -{ - type patch; - nFaces 25; - startFace 3650; -} - -outlet -{ - type patch; - nFaces 25; - startFace 3675; -} - -walls -{ - type wall; - nFaces 150; - startFace 3700; -} - -defaultFaces -{ - type empty; - nFaces 3750; - startFace 3850; -} + inlet + { + type patch; + nFaces 25; + startFace 3650; + } + outlet + { + type patch; + nFaces 25; + startFace 3675; + } + walls + { + type wall; + nFaces 150; + startFace 3700; + } + defaultFaces + { + type empty; + nFaces 3750; + startFace 3850; + } ) // ************************************************************************* // diff --git a/tutorials/stressAnalysis/solidDisplacementFoam/plateHole/constant/polyMesh/boundary b/tutorials/stressAnalysis/solidDisplacementFoam/plateHole/constant/polyMesh/boundary index e58f9c5921..1d54b63e6b 100644 --- a/tutorials/stressAnalysis/solidDisplacementFoam/plateHole/constant/polyMesh/boundary +++ b/tutorials/stressAnalysis/solidDisplacementFoam/plateHole/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,53 +10,49 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 6 ( -left -{ - type symmetryPlane; - nFaces 30; - startFace 1930; -} - -right -{ - type patch; - nFaces 30; - startFace 1960; -} - -down -{ - type symmetryPlane; - nFaces 30; - startFace 1990; -} - -up -{ - type patch; - nFaces 30; - startFace 2020; -} - -hole -{ - type patch; - nFaces 20; - startFace 2050; -} - -frontAndBack -{ - type empty; - nFaces 2000; - startFace 2070; -} + left + { + type symmetryPlane; + nFaces 30; + startFace 1930; + } + right + { + type patch; + nFaces 30; + startFace 1960; + } + down + { + type symmetryPlane; + nFaces 30; + startFace 1990; + } + up + { + type patch; + nFaces 30; + startFace 2020; + } + hole + { + type patch; + nFaces 20; + startFace 2050; + } + frontAndBack + { + type empty; + nFaces 2000; + startFace 2070; + } ) // ************************************************************************* // diff --git a/tutorials/stressAnalysis/solidEquilibriumDisplacementFoam/beamEndLoad/constant/polyMesh/boundary b/tutorials/stressAnalysis/solidEquilibriumDisplacementFoam/beamEndLoad/constant/polyMesh/boundary index 89fde8381b..bc163bf797 100644 --- a/tutorials/stressAnalysis/solidEquilibriumDisplacementFoam/beamEndLoad/constant/polyMesh/boundary +++ b/tutorials/stressAnalysis/solidEquilibriumDisplacementFoam/beamEndLoad/constant/polyMesh/boundary @@ -1,8 +1,8 @@ /*--------------------------------*- C++ -*----------------------------------*\ | ========= | | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | -| \\ / O peration | Version: 1.5 | -| \\ / A nd | Web: http://www.OpenFOAM.org | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: www.OpenFOAM.org | | \\/ M anipulation | | \*---------------------------------------------------------------------------*/ FoamFile @@ -10,46 +10,43 @@ FoamFile version 2.0; format ascii; class polyBoundaryMesh; + location "constant/polyMesh"; object boundary; } // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // 5 ( -topSurface -{ - type patch; - nFaces 6; - startFace 16; -} - -bottomSurface -{ - type patch; - nFaces 6; - startFace 22; -} - -fixedEnd -{ - type wall; - nFaces 2; - startFace 28; -} - -tractionEnd -{ - type patch; - nFaces 2; - startFace 30; -} - -defaultFaces -{ - type empty; - nFaces 24; - startFace 32; -} + topSurface + { + type patch; + nFaces 6; + startFace 16; + } + bottomSurface + { + type patch; + nFaces 6; + startFace 22; + } + fixedEnd + { + type wall; + nFaces 2; + startFace 28; + } + tractionEnd + { + type patch; + nFaces 2; + startFace 30; + } + defaultFaces + { + type empty; + nFaces 24; + startFace 32; + } ) // ************************************************************************* //