GIT: Resolved conflict

This commit is contained in:
Andrew Heather
2015-12-09 09:32:38 +00:00
246 changed files with 4020 additions and 788 deletions

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpDNSSolvers Direct Numerical Simulation solvers
@{
\ingroup grpSolvers
This group contains Direct Numerical Simulation (DNS) solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
dnsFoam dnsFoam
Group
grpDNSSolvers
Description Description
Direct numerical simulation solver for boxes of isotropic turbulence Direct numerical simulation solver for boxes of isotropic turbulence

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpBasicSolvers Basic solvers
@{
\ingroup grpSolvers
This group contains basic solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,8 +24,30 @@ License
Application Application
laplacianFoam laplacianFoam
Group
grpBasicSolvers
Description Description
Solves a simple Laplace equation, e.g. for thermal diffusion in a solid. Laplace equation solver for a scalar quantity.
\heading Solver details
The solver is applicable to, e.g. for thermal diffusion in a solid. The
equation is given by:
\f[
\ddt{T} = \div \left( D_T \grad T \right)
\f]
Where:
\vartable
T | Scalar field which is solved for, e.g. temperature
D_T | Diffusion coefficient
\endvartable
\heading Required fields
\plaintable
T | Scalar field which is solved for, e.g. temperature
\endplaintable
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View File

@ -24,8 +24,32 @@ License
Application Application
scalarTransportFoam scalarTransportFoam
Group
grpBasicSolvers
Description Description
Solves a transport equation for a passive scalar Passive scalar transport equation solver.
\heading Solver details
The equation is given by:
\f[
\ddt{T} + \div \left(\vec{U} T\right) - \div \left(D_T \grad T \right)
= S_{T}
\f]
Where:
\vartable
T | Passive scalar
D_T | Diffusion coefficient
S_T | Source
\endvartable
\heading Required fields
\plaintable
T | Passive scalar
U | Velocity [m/s]
\endplaintable
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
PDRFoam PDRFoam
Group
grpCombustionSolvers
Description Description
Solver for compressible premixed/partially-premixed combustion with Solver for compressible premixed/partially-premixed combustion with
turbulence modelling. turbulence modelling.
@ -54,16 +57,17 @@ Description
regions containing blockages which cannot be resolved by the mesh. regions containing blockages which cannot be resolved by the mesh.
The fields used by this solver are: The fields used by this solver are:
\plaintable
betav: Volume porosity betav | Volume porosity
Lobs: Average diameter of obstacle in cell (m) Lobs | Average diameter of obstacle in cell (m)
Aw: Obstacle surface area per unit volume (1/m) Aw | Obstacle surface area per unit volume (1/m)
CR: Drag tensor (1/m) CR | Drag tensor (1/m)
CT: Turbulence generation parameter (1/m) CT | Turbulence generation parameter (1/m)
Nv: Number of obstacles in cell per unit volume (m^-2) Nv | Number of obstacles in cell per unit volume (m^-2)
nsv: Tensor whose diagonal indicates the number to substract from nsv | Tensor whose diagonal indicates the number to substract from
Nv to get the number of obstacles crossing the flow in each | Nv to get the number of obstacles crossing the flow in each
direction. | direction.
\endplaintable
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
XiFoam XiFoam
Group
grpCombustionSolvers grpMovingMeshSolvers
Description Description
Solver for compressible premixed/partially-premixed combustion with Solver for compressible premixed/partially-premixed combustion with
turbulence modelling. turbulence modelling.

View File

@ -24,6 +24,9 @@ License
Application Application
XiFoam XiFoam
Group
grpCombustionSolvers
Description Description
Solver for compressible premixed/partially-premixed combustion with Solver for compressible premixed/partially-premixed combustion with
turbulence modelling. turbulence modelling.

View File

@ -24,6 +24,9 @@ License
Application Application
chemFoam chemFoam
Group
grpCombustionSolvers
Description Description
Solver for chemistry problems Solver for chemistry problems
- designed for use on single cell cases to provide comparison against - designed for use on single cell cases to provide comparison against

View File

@ -22,7 +22,10 @@ License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>. along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
Application Application
engineFoam coldEngineFoam
Group
grpCombustionSolvers grpMovingMeshSolvers
Description Description
Solver for cold-flow in internal combustion engines. Solver for cold-flow in internal combustion engines.

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpCombustionSolvers Combustion solvers
@{
\ingroup grpSolvers
This group contains combustion solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
engineFoam engineFoam
Group
grpCombustionSolvers
Description Description
Solver for internal combustion engines. Solver for internal combustion engines.

View File

@ -24,8 +24,11 @@ License
Application Application
fireFoam fireFoam
Group
grpCombustionSolvers
Description Description
Transient PIMPLE solver for Fires and turbulent diffusion flames with Transient PIMPLE solver for fires and turbulent diffusion flames with
reacting Lagrangian parcels, surface film and pyrolysis modelling. reacting Lagrangian parcels, surface film and pyrolysis modelling.
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
reactingFoam reactingFoam
Group
grpCombustionSolvers
Description Description
Solver for combustion with chemical reactions. Solver for combustion with chemical reactions.

View File

@ -24,6 +24,9 @@ License
Application Application
rhoReactingBuoyantFoam rhoReactingBuoyantFoam
Group
grpCombustionSolvers
Description Description
Solver for combustion with chemical reactions using density based Solver for combustion with chemical reactions using density based
thermodynamics package, using enahanced buoyancy treatment. thermodynamics package, using enahanced buoyancy treatment.

View File

@ -24,6 +24,9 @@ License
Application Application
rhoReactingFoam rhoReactingFoam
Group
grpCombustionSolvers
Description Description
Solver for combustion with chemical reactions using density based Solver for combustion with chemical reactions using density based
thermodynamics package. thermodynamics package.

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpCompressibleSolvers Compressible flow solvers
@{
\ingroup grpSolvers
This group contains compressible flow solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
rhoCentralDyMFoam rhoCentralDyMFoam
Group
grpCompressibleSolvers grpMovingMeshSolvers
Description Description
Density-based compressible flow solver based on central-upwind schemes of Density-based compressible flow solver based on central-upwind schemes of
Kurganov and Tadmor with support for mesh-motion and topology changes Kurganov and Tadmor with support for mesh-motion and topology changes

View File

@ -24,6 +24,9 @@ License
Application Application
rhoCentralFoam rhoCentralFoam
Group
grpCompressibleSolvers
Description Description
Density-based compressible flow solver based on central-upwind schemes of Density-based compressible flow solver based on central-upwind schemes of
Kurganov and Tadmor Kurganov and Tadmor

View File

@ -24,6 +24,9 @@ License
Application Application
rhoPimpleFoam rhoPimpleFoam
Group
grpCompressibleSolvers
Description Description
Transient solver for laminar or turbulent flow of compressible fluids Transient solver for laminar or turbulent flow of compressible fluids
for HVAC and similar applications. for HVAC and similar applications.

View File

@ -24,6 +24,9 @@ License
Application Application
rhoPorousSimpleFoam rhoPorousSimpleFoam
Group
grpCompressibleSolvers
Description Description
Steady-state solver for turbulent flow of compressible fluids with Steady-state solver for turbulent flow of compressible fluids with
RANS turbulence modelling, implicit or explicit porosity treatment RANS turbulence modelling, implicit or explicit porosity treatment

View File

@ -24,6 +24,9 @@ License
Application Application
rhoSimpleFoam rhoSimpleFoam
Group
grpCompressibleSolvers
Description Description
Steady-state SIMPLE solver for laminar or turbulent RANS flow of Steady-state SIMPLE solver for laminar or turbulent RANS flow of
compressible fluids. compressible fluids.

View File

@ -21,6 +21,9 @@ License
You should have received a copy of the GNU General Public License You should have received a copy of the GNU General Public License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>. along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
Group
grpCompressibleSolvers
Application Application
sonicLiquidFoam sonicLiquidFoam

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpDiscreteMethodsSolvers Discrete method solvers
@{
\ingroup grpSolvers
This group contains discrete method solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
dsmcFoam dsmcFoam
Group
grpDiscreteMethodsSolvers
Description Description
Direct simulation Monte Carlo (DSMC) solver for 3D, transient, multi- Direct simulation Monte Carlo (DSMC) solver for 3D, transient, multi-
species flows species flows

View File

@ -24,6 +24,9 @@ License
Application Application
mdEquilibrationFoam mdEquilibrationFoam
Group
grpDiscreteMethodsSolvers
Description Description
Equilibrates and/or preconditions molecular dynamics systems Equilibrates and/or preconditions molecular dynamics systems

View File

@ -24,6 +24,9 @@ License
Application Application
mdFoam mdFoam
Group
grpDiscreteMethodsSolvers
Description Description
Molecular dynamics solver for fluid dynamics Molecular dynamics solver for fluid dynamics

View File

@ -0,0 +1,44 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
\page pageSolvers Solvers
\section secSolvers Overview
The available solvers are grouped into the following categories:
- \ref grpBasicSolvers
- \ref grpCombustionSolvers
- \ref grpCompressibleSolvers
- \ref grpDiscreteMethodsSolvers
- \ref grpDNSSolvers
- \ref grpElectroMagneticsSolvers
- \ref grpFinancialSolvers
- \ref grpHeatTransferSolvers
- \ref grpIncompressibleSolvers
- \ref grpLagrangianSolvers
- \ref grpMultiphaseSolvers
- \ref grpStressAnalysisSolvers
\*---------------------------------------------------------------------------*/

View File

@ -0,0 +1,37 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
\defgroup grpSolvers Solvers
@{
This group contains solvers
@}
\defgroup grpMovingMeshSolvers Moving mesh solvers
@{
\ingroup grpSolvers
This group contains moving mesh solvers solvers
@}
\*---------------------------------------------------------------------------*/

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpElectroMagneticsSolvers Electro-magnetics solvers
@{
\ingroup grpSolvers
This group contains electro-magnetics solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
electrostaticFoam electrostaticFoam
Group
grpElectroMagneticsSolvers
Description Description
Solver for electrostatics. Solver for electrostatics.

View File

@ -24,6 +24,9 @@ License
Application Application
magneticFoam magneticFoam
Group
grpElectroMagneticsSolvers
Description Description
Solver for the magnetic field generated by permanent magnets. Solver for the magnetic field generated by permanent magnets.

View File

@ -24,6 +24,9 @@ License
Application Application
mhdFoam mhdFoam
Group
grpElectroMagneticsSolvers
Description Description
Solver for magnetohydrodynamics (MHD): incompressible, laminar flow of a Solver for magnetohydrodynamics (MHD): incompressible, laminar flow of a
conducting fluid under the influence of a magnetic field. conducting fluid under the influence of a magnetic field.

View File

@ -24,6 +24,9 @@ License
Application Application
financialFoam financialFoam
Group
grpFinancialSolvers
Description Description
Solves the Black-Scholes equation to price commodities. Solves the Black-Scholes equation to price commodities.

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpFinancialSolvers Financial solvers
@{
\ingroup grpSolvers
This group contains financial solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
buoyantBoussinesqPimpleFoam buoyantBoussinesqPimpleFoam
Group
grpHeatTransferSolvers
Description Description
Transient solver for buoyant, turbulent flow of incompressible fluids Transient solver for buoyant, turbulent flow of incompressible fluids

View File

@ -24,6 +24,9 @@ License
Application Application
buoyantBoussinesqSimpleFoam buoyantBoussinesqSimpleFoam
Group
grpHeatTransferSolvers
Description Description
Steady-state solver for buoyant, turbulent flow of incompressible fluids Steady-state solver for buoyant, turbulent flow of incompressible fluids

View File

@ -24,6 +24,9 @@ License
Application Application
buoyantPimpleFoam buoyantPimpleFoam
Group
grpHeatTransferSolvers
Description Description
Transient solver for buoyant, turbulent flow of compressible fluids for Transient solver for buoyant, turbulent flow of compressible fluids for
ventilation and heat-transfer. ventilation and heat-transfer.

View File

@ -24,6 +24,9 @@ License
Application Application
buoyantSimpleFoam buoyantSimpleFoam
Group
grpHeatTransferSolvers
Description Description
Steady-state solver for buoyant, turbulent flow of compressible fluids, Steady-state solver for buoyant, turbulent flow of compressible fluids,
including radiation, for ventilation and heat-transfer. including radiation, for ventilation and heat-transfer.

View File

@ -24,6 +24,9 @@ License
Application Application
chtMultiRegionFoam chtMultiRegionFoam
Group
grpHeatTransferSolvers
Description Description
Combination of heatConductionFoam and buoyantFoam for conjugate heat Combination of heatConductionFoam and buoyantFoam for conjugate heat
transfer between solid regions and fluid regions. Both regions include transfer between solid regions and fluid regions. Both regions include

View File

@ -24,6 +24,9 @@ License
Application Application
chtMultiRegionSimpleFoam chtMultiRegionSimpleFoam
Group
grpHeatTransferSolvers
Description Description
Steady-state version of chtMultiRegionFoam Steady-state version of chtMultiRegionFoam

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpHeatTransferSolvers Heat transfer solvers
@{
\ingroup grpSolvers
This group contains heat transfer solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
thermoFoam thermoFoam
Group
grpHeatTransferSolvers
Description Description
Evolves the thermodynamics on a frozen flow field Evolves the thermodynamics on a frozen flow field

View File

@ -24,6 +24,9 @@ License
Application Application
ajointShapeOptimizationFoam ajointShapeOptimizationFoam
Group
grpIncompressibleSolvers
Description Description
Steady-state solver for incompressible, turbulent flow of non-Newtonian Steady-state solver for incompressible, turbulent flow of non-Newtonian
fluids with optimisation of duct shape by applying "blockage" in regions fluids with optimisation of duct shape by applying "blockage" in regions

View File

@ -24,6 +24,9 @@ License
Application Application
boundaryFoam boundaryFoam
Group
grpIncompressibleSolvers
Description Description
Steady-state solver for incompressible, 1D turbulent flow, typically to Steady-state solver for incompressible, 1D turbulent flow, typically to
generate boundary layer conditions at an inlet, for use in a simulation. generate boundary layer conditions at an inlet, for use in a simulation.

View File

@ -24,9 +24,40 @@ License
Application Application
icoFoam icoFoam
Group
grpIncompressibleSolvers
Description Description
Transient solver for incompressible, laminar flow of Newtonian fluids. Transient solver for incompressible, laminar flow of Newtonian fluids.
\heading Solver details
The solver uses the PISO algorithm to solve the continuity equation:
\f[
\div \vec{U} = 0
\f]
and momentum equation:
\f[
\ddt{\vec{U}}
+ \div \left( \vec{U} \vec{U} \right)
- \div \left(\nu \grad \vec{U} \right)
= - \grad p
\f]
Where:
\vartable
\vec{U} | Velocity
p | Pressure
\endvartable
\heading Required fields
\plaintable
U | Velocity [m/s]
p | Kinematic pressure, p/rho [m2/s2]
\endplaintable
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "fvCFD.H" #include "fvCFD.H"

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpIncompressibleSolvers Incompressible flow solvers
@{
\ingroup grpSolvers
This group contains incompressible flow solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
nonNewtonianIcoFoam nonNewtonianIcoFoam
Group
grpIncompressibleSolvers
Description Description
Transient solver for incompressible, laminar flow of non-Newtonian fluids. Transient solver for incompressible, laminar flow of non-Newtonian fluids.

View File

@ -24,6 +24,9 @@ License
Application Application
SRFPimpleFoam SRFPimpleFoam
Group
grpIncompressibleSolvers
Description Description
Large time-step transient solver for incompressible, flow in a single Large time-step transient solver for incompressible, flow in a single
rotating frame using the PIMPLE (merged PISO-SIMPLE) algorithm. rotating frame using the PIMPLE (merged PISO-SIMPLE) algorithm.

View File

@ -24,6 +24,9 @@ License
Application Application
pimpleDyMFoam.C pimpleDyMFoam.C
Group
grpIncompressibleSolvers grpMovingMeshSolvers
Description Description
Transient solver for incompressible, flow of Newtonian fluids Transient solver for incompressible, flow of Newtonian fluids
on a moving mesh using the PIMPLE (merged PISO-SIMPLE) algorithm. on a moving mesh using the PIMPLE (merged PISO-SIMPLE) algorithm.

View File

@ -24,14 +24,47 @@ License
Application Application
pimpleFoam pimpleFoam
Group
grpIncompressibleSolvers
Description Description
Large time-step transient solver for incompressible, flow using the PIMPLE Large time-step transient solver for incompressible, flow using the PIMPLE
(merged PISO-SIMPLE) algorithm. (merged PISO-SIMPLE) algorithm.
\heading Solver details
The solver uses the PIMPLE (merged PISO-SIMPLE) algorithm to solve the
continuity equation:
\f[
\div \vec{U} = 0
\f]
and momentum equation:
\f[
\ddt{\vec{U}} + \div \left( \vec{U} \vec{U} \right) - \div \gvec{R}
= - \grad p + \vec{S}_U
\f]
Where:
\vartable
\vec{U} | Velocity
p | Pressure
\vec{R} | Stress tensor
\vec{S}_U | Momentum source
\endvartable
Sub-models include: Sub-models include:
- turbulence modelling, i.e. laminar, RAS or LES - turbulence modelling, i.e. laminar, RAS or LES
- run-time selectable MRF and finite volume options, e.g. explicit porosity - run-time selectable MRF and finite volume options, e.g. explicit porosity
\heading Required fields
\plaintable
U | Velocity [m/s]
p | Kinematic pressure, p/rho [m2/s2]
\<turbulence fields\> | As required by user selection
\endplaintable
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "fvCFD.H" #include "fvCFD.H"

View File

@ -24,13 +24,44 @@ License
Application Application
pisoFoam pisoFoam
Group
grpIncompressibleSolvers
Description Description
Transient solver for incompressible flow. Transient solver for incompressible flow.
\heading Solver details
The solver uses the PISO algorithm to solve the continuity equation:
\f[
\div \vec{U} = 0
\f]
and momentum equation:
\f[
\ddt{\vec{U}} + \div \left( \vec{U} \vec{U} \right) - \div \gvec{R}
= - \grad p
\f]
Where:
\vartable
\vec{U} | Velocity
p | Pressure
\vec{R} | Stress tensor
\endvartable
Sub-models include: Sub-models include:
- turbulence modelling, i.e. laminar, RAS or LES - turbulence modelling, i.e. laminar, RAS or LES
- run-time selectable MRF and finite volume options, e.g. explicit porosity - run-time selectable MRF and finite volume options, e.g. explicit porosity
\heading Required fields
\plaintable
U | Velocity [m/s]
p | Kinematic pressure, p/rho [m2/s2]
\<turbulence fields\> | As required by user selection
\endplaintable
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "fvCFD.H" #include "fvCFD.H"

View File

@ -24,6 +24,9 @@ License
Application Application
shallowWaterFoam shallowWaterFoam
Group
grpIncompressibleSolvers
Description Description
Transient solver for inviscid shallow-water equations with rotation. Transient solver for inviscid shallow-water equations with rotation.

View File

@ -24,6 +24,9 @@ License
Application Application
SRFSimpleFoam SRFSimpleFoam
Group
grpIncompressibleSolvers
Description Description
Steady-state solver for incompressible, turbulent flow of non-Newtonian Steady-state solver for incompressible, turbulent flow of non-Newtonian
fluids in a single rotating frame. fluids in a single rotating frame.

View File

@ -24,6 +24,9 @@ License
Application Application
porousSimpleFoam porousSimpleFoam
Group
grpIncompressibleSolvers
Description Description
Steady-state solver for incompressible, turbulent flow with Steady-state solver for incompressible, turbulent flow with
implicit or explicit porosity treatment and support for multiple reference implicit or explicit porosity treatment and support for multiple reference

View File

@ -24,8 +24,40 @@ License
Application Application
simpleFoam simpleFoam
Group
grpIncompressibleSolvers
Description Description
Steady-state solver for incompressible, turbulent flow Steady-state solver for incompressible flows with turbulence modelling.
\heading Solver details
The solver uses the SIMPLE algorithm to solve the continuity equation:
\f[
\div \vec{U} = 0
\f]
and momentum equation:
\f[
\div \left( \vec{U} \vec{U} \right) - \div \gvec{R}
= - \grad p + \vec{S}_U
\f]
Where:
\vartable
\vec{U} | Velocity
p | Pressure
\vec{R} | Stress tensor
\vec{S}_U | Momentum source
\endvartable
\heading Required fields
\plaintable
U | Velocity [m/s]
p | Kinematic pressure, p/rho [m2/s2]
\<turbulence fields\> | As required by user selection
\endplaintable
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
DPMFoam DPMFoam
Group
grpLagrangianSolvers
Description Description
Transient solver for the coupled transport of a single kinematic particle Transient solver for the coupled transport of a single kinematic particle
cloud including the effect of the volume fraction of particles on the cloud including the effect of the volume fraction of particles on the

View File

@ -24,6 +24,9 @@ License
Application Application
MPPICFoam MPPICFoam
Group
grpLagrangianSolvers
Description Description
Transient solver for the coupled transport of a single kinematic particle Transient solver for the coupled transport of a single kinematic particle
cloud including the effect of the volume fraction of particles on the cloud including the effect of the volume fraction of particles on the

View File

@ -24,6 +24,9 @@ License
Application Application
coalChemistryFoam coalChemistryFoam
Group
grpLagrangianSolvers
Description Description
Transient solver for: Transient solver for:
- compressible, - compressible,

View File

@ -24,6 +24,9 @@ License
Application Application
uncoupledKinematicParcelDyMFoam uncoupledKinematicParcelDyMFoam
Group
grpLagrangianSolvers grpMovingMeshSolvers
Description Description
Transient solver for the passive transport of a single kinematic Transient solver for the passive transport of a single kinematic
particle cloud. particle cloud.

View File

@ -24,6 +24,9 @@ License
Application Application
icoUncoupledKinematicParcelFoam icoUncoupledKinematicParcelFoam
Group
grpLagrangianSolvers
Description Description
Transient solver for the passive transport of a single kinematic Transient solver for the passive transport of a single kinematic
particle cloud. particle cloud.

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpLagrangianSolvers Lagrangian solvers
@{
\ingroup grpSolvers
This group contains Lagrangian solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
reactingParcelFilmFoam reactingParcelFilmFoam
Group
grpLagrangianSolvers
Description Description
Transient PIMPLE solver for compressible, laminar or turbulent flow with Transient PIMPLE solver for compressible, laminar or turbulent flow with
reacting Lagrangian parcels, and surface film modelling. reacting Lagrangian parcels, and surface film modelling.

View File

@ -24,6 +24,9 @@ License
Application Application
reactingParcelFoam reactingParcelFoam
Group
grpLagrangianSolvers
Description Description
Transient PIMPLE solver for compressible, laminar or turbulent flow with Transient PIMPLE solver for compressible, laminar or turbulent flow with
reacting multiphase Lagrangian parcels, including run-time selectable reacting multiphase Lagrangian parcels, including run-time selectable

View File

@ -24,6 +24,9 @@ License
Application Application
simpleReactingParcelFoam simpleReactingParcelFoam
Group
grpLagrangianSolvers
Description Description
Steady state SIMPLE solver for compressible, laminar or turbulent flow with Steady state SIMPLE solver for compressible, laminar or turbulent flow with
reacting multiphase Lagrangian parcels, including run-time selectable reacting multiphase Lagrangian parcels, including run-time selectable

View File

@ -24,6 +24,9 @@ License
Application Application
sprayDyMFoam sprayDyMFoam
Group
grpLagrangianSolvers grpMovingMeshSolvers
Description Description
Transient PIMPLE solver for compressible, laminar or turbulent flow with Transient PIMPLE solver for compressible, laminar or turbulent flow with
spray parcels and support for moving meshes. spray parcels and support for moving meshes.

View File

@ -24,6 +24,9 @@ License
Application Application
sprayEngineFoam sprayEngineFoam
Group
grpLagrangianSolvers grpMovingMeshSolvers
Description Description
Transient PIMPLE solver for compressible, laminar or turbulent engine Transient PIMPLE solver for compressible, laminar or turbulent engine
flow swith spray parcels. flow swith spray parcels.

View File

@ -24,6 +24,9 @@ License
Application Application
sprayFoam sprayFoam
Group
grpLagrangianSolvers
Description Description
Transient PIMPLE solver for compressible, laminar or turbulent flow with Transient PIMPLE solver for compressible, laminar or turbulent flow with
spray parcels. spray parcels.

View File

@ -24,6 +24,9 @@ License
Application Application
uncoupledKinematicParcelFoam uncoupledKinematicParcelFoam
Group
grpLagrangianSolvers
Description Description
Transient solver for the passive transport of a single kinematic Transient solver for the passive transport of a single kinematic
particle cloud. particle cloud.

View File

@ -24,6 +24,9 @@ License
Application Application
cavitatingFoam cavitatingFoam
Group
grpMultiphaseSolvers grpMovingMeshSolvers
Description Description
Transient cavitation code based on the homogeneous equilibrium model Transient cavitation code based on the homogeneous equilibrium model
from which the compressibility of the liquid/vapour "mixture" is obtained. from which the compressibility of the liquid/vapour "mixture" is obtained.

View File

@ -24,6 +24,9 @@ License
Application Application
cavitatingFoam cavitatingFoam
Group
grpMultiphaseSolvers
Description Description
Transient cavitation code based on the homogeneous equilibrium model Transient cavitation code based on the homogeneous equilibrium model
from which the compressibility of the liquid/vapour "mixture" is obtained. from which the compressibility of the liquid/vapour "mixture" is obtained.

View File

@ -24,6 +24,9 @@ License
Application Application
compressibleInterDyMFoam compressibleInterDyMFoam
Group
grpMultiphaseSolvers grpMovingMeshSolvers
Description Description
Solver for 2 compressible, non-isothermal immiscible fluids using a VOF Solver for 2 compressible, non-isothermal immiscible fluids using a VOF
(volume of fluid) phase-fraction based interface capturing approach, (volume of fluid) phase-fraction based interface capturing approach,

View File

@ -24,6 +24,9 @@ License
Application Application
compressibleInterFoam compressibleInterFoam
Group
grpMultiphaseSolvers
Description Description
Solver for 2 compressible, non-isothermal immiscible fluids using a VOF Solver for 2 compressible, non-isothermal immiscible fluids using a VOF
(volume of fluid) phase-fraction based interface capturing approach. (volume of fluid) phase-fraction based interface capturing approach.

View File

@ -24,6 +24,9 @@ License
Application Application
compressibleMultiphaseInterFoam compressibleMultiphaseInterFoam
Group
grpMultiphaseSolvers
Description Description
Solver for n compressible, non-isothermal immiscible fluids using a VOF Solver for n compressible, non-isothermal immiscible fluids using a VOF
(volume of fluid) phase-fraction based interface capturing approach. (volume of fluid) phase-fraction based interface capturing approach.

View File

@ -24,6 +24,9 @@ License
Application Application
driftFluxFoam driftFluxFoam
Group
grpMultiphaseSolvers
Description Description
Solver for 2 incompressible fluids using the mixture approach with the Solver for 2 incompressible fluids using the mixture approach with the
drift-flux approximation for relative motion of the phases. drift-flux approximation for relative motion of the phases.

View File

@ -24,6 +24,9 @@ License
Application Application
interDyMFoam interDyMFoam
Group
grpMultiphaseSolvers grpMovingMeshSolvers
Description Description
Solver for 2 incompressible, isothermal immiscible fluids using a VOF Solver for 2 incompressible, isothermal immiscible fluids using a VOF
(volume of fluid) phase-fraction based interface capturing approach, (volume of fluid) phase-fraction based interface capturing approach,

View File

@ -24,6 +24,9 @@ License
Application Application
interFoam interFoam
Group
grpMultiphaseSolvers
Description Description
Solver for 2 incompressible, isothermal immiscible fluids using a VOF Solver for 2 incompressible, isothermal immiscible fluids using a VOF
(volume of fluid) phase-fraction based interface capturing approach. (volume of fluid) phase-fraction based interface capturing approach.

View File

@ -24,6 +24,9 @@ License
Application Application
interMixingFoam interMixingFoam
Group
grpMultiphaseSolvers
Description Description
Solver for 3 incompressible fluids, two of which are miscible, Solver for 3 incompressible fluids, two of which are miscible,
using a VOF method to capture the interface. using a VOF method to capture the interface.

View File

@ -24,6 +24,9 @@ License
Application Application
interPhaseChangeDyMFoam interPhaseChangeDyMFoam
Group
grpMultiphaseSolvers grpMovingMeshSolvers
Description Description
Solver for 2 incompressible, isothermal immiscible fluids with phase-change Solver for 2 incompressible, isothermal immiscible fluids with phase-change
(e.g. cavitation). Uses a VOF (volume of fluid) phase-fraction based (e.g. cavitation). Uses a VOF (volume of fluid) phase-fraction based

View File

@ -24,6 +24,9 @@ License
Application Application
interPhaseChangeFoam interPhaseChangeFoam
Group
grpMultiphaseSolvers
Description Description
Solver for 2 incompressible, isothermal immiscible fluids with phase-change Solver for 2 incompressible, isothermal immiscible fluids with phase-change
(e.g. cavitation). Uses a VOF (volume of fluid) phase-fraction based (e.g. cavitation). Uses a VOF (volume of fluid) phase-fraction based

View File

@ -24,6 +24,9 @@ License
Application Application
multiphaseEulerFoam multiphaseEulerFoam
Group
grpMultiphaseSolvers
Description Description
Solver for a system of many compressible fluid phases including Solver for a system of many compressible fluid phases including
heat-transfer. heat-transfer.

View File

@ -24,6 +24,9 @@ License
Application Application
multiphaseInterFoam multiphaseInterFoam
Group
grpMultiphaseSolvers grpMovingMeshSolvers
Description Description
Solver for n incompressible fluids which captures the interfaces and Solver for n incompressible fluids which captures the interfaces and
includes surface-tension and contact-angle effects for each phase. includes surface-tension and contact-angle effects for each phase.

View File

@ -24,6 +24,9 @@ License
Application Application
multiphaseInterFoam multiphaseInterFoam
Group
grpMultiphaseSolvers
Description Description
Solver for n incompressible fluids which captures the interfaces and Solver for n incompressible fluids which captures the interfaces and
includes surface-tension and contact-angle effects for each phase. includes surface-tension and contact-angle effects for each phase.

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpMultiphaseSolvers Multiphase solvers
@{
\ingroup grpSolvers
This group contains multiphase solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -24,6 +24,9 @@ License
Application Application
potentialFreeSurfaceDyMFoam potentialFreeSurfaceDyMFoam
Group
grpMultiphaseSolvers grpMovingMeshSolvers
Description Description
Incompressible Navier-Stokes solver with inclusion of a wave height field Incompressible Navier-Stokes solver with inclusion of a wave height field
to enable single-phase free-surface approximations. to enable single-phase free-surface approximations.

View File

@ -24,6 +24,9 @@ License
Application Application
potentialFreeSurfaceFoam potentialFreeSurfaceFoam
Group
grpMultiphaseSolvers
Description Description
Incompressible Navier-Stokes solver with inclusion of a wave height field Incompressible Navier-Stokes solver with inclusion of a wave height field
to enable single-phase free-surface approximations to enable single-phase free-surface approximations

View File

@ -24,6 +24,9 @@ License
Application Application
reactingMultiphaseEulerFoam reactingMultiphaseEulerFoam
Group
grpMultiphaseSolvers
Description Description
Solver for a system of any number of compressible fluid phases with a Solver for a system of any number of compressible fluid phases with a
common pressure, but otherwise separate properties. The type of phase model common pressure, but otherwise separate properties. The type of phase model

View File

@ -24,6 +24,9 @@ License
Application Application
reactingTwoPhaseEulerFoam reactingTwoPhaseEulerFoam
Group
grpMultiphaseSolvers
Description Description
Solver for a system of 2 compressible fluid phases with a common pressure, Solver for a system of 2 compressible fluid phases with a common pressure,
but otherwise separate properties. The type of phase model is run time but otherwise separate properties. The type of phase model is run time

View File

@ -24,6 +24,9 @@ License
Application Application
twoLiquidMixingFoam twoLiquidMixingFoam
Group
grpMultiphaseSolvers
Description Description
Solver for mixing 2 incompressible fluids. Solver for mixing 2 incompressible fluids.

View File

@ -24,6 +24,9 @@ License
Application Application
twoPhaseEulerFoam twoPhaseEulerFoam
Group
grpMultiphaseSolvers
Description Description
Solver for a system of 2 compressible fluid phases with one phase Solver for a system of 2 compressible fluid phases with one phase
dispersed, e.g. gas bubbles in a liquid including heat-transfer. dispersed, e.g. gas bubbles in a liquid including heat-transfer.

View File

@ -24,6 +24,9 @@ License
Application Application
solidDisplacementFoam solidDisplacementFoam
Group
grpStressAnalysisSolvers
Description Description
Transient segregated finite-volume solver of linear-elastic, Transient segregated finite-volume solver of linear-elastic,
small-strain deformation of a solid body, with optional thermal small-strain deformation of a solid body, with optional thermal

View File

@ -24,6 +24,9 @@ License
Application Application
solidEquilibriumDisplacementFoam solidEquilibriumDisplacementFoam
Group
grpStressAnalysisSolvers
Description Description
Steady-state segregated finite-volume solver of linear-elastic, Steady-state segregated finite-volume solver of linear-elastic,
small-strain deformation of a solid body, with optional thermal small-strain deformation of a solid body, with optional thermal

View File

@ -0,0 +1,30 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation, either version 3 of the License, or (at your option)
any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
details.
You should have received a copy of the GNU General Public License along with
OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\defgroup grpStressAnalysisSolvers Stress analysis solvers
@{
\ingroup grpSolvers
This group contains stress analysis solvers.
@}
\*---------------------------------------------------------------------------*/

View File

@ -34,7 +34,8 @@ Description
NOTE: To avoid exposing wrong fields values faceSets should include NOTE: To avoid exposing wrong fields values faceSets should include
faces contained in the blockedCells cellset. faces contained in the blockedCells cellset.
- coupledFaces reads coupledFacesSet to introduces mixe-coupled baffles - coupledFaces reads coupledFacesSet to introduces mixed-coupled
duplicate baffles
Subsets out the blocked cells and splits the blockedFaces and updates Subsets out the blocked cells and splits the blockedFaces and updates
fields. fields.

View File

@ -17,7 +17,8 @@ FoamFile
//- Per faceSet the patch the faces should go into blocked baffles //- Per faceSet the patch the faces should go into blocked baffles
blockedFaces ((blockedFacesSet blockedFaces)); blockedFaces ((blockedFacesSet blockedFaces));
//- Per faceSet the patch the faces should go into coupled baffles //- Per faceSet the duplicate baffles to generate (one 'normal', wall baffle,
// one cyclic baffle). For use with active baffle boundary conditions.
coupledFaces coupledFaces
{ {
coupledFacesSet coupledFacesSet

View File

@ -525,7 +525,7 @@ int main(int argc, char *argv[])
Info<< "Created zone " << name Info<< "Created zone " << name
<< " at index " << zoneID << " at index " << zoneID
<< " with " << n << " faces" << endl; << " with " << returnReduce(n, sumOp<label>()) << " faces" << endl;
mesh.faceZones().set mesh.faceZones().set
( (

View File

@ -504,6 +504,11 @@ int main(int argc, char *argv[])
#include "addOverwriteOption.H" #include "addOverwriteOption.H"
#include "addRegionOption.H" #include "addRegionOption.H"
#include "addDictOption.H" #include "addDictOption.H"
Foam::argList::addBoolOption
(
"writeObj",
"write obj files showing the cyclic matching process"
);
#include "setRootCase.H" #include "setRootCase.H"
#include "createTime.H" #include "createTime.H"
runTime.functionObjects().off(); runTime.functionObjects().off();
@ -515,12 +520,13 @@ int main(int argc, char *argv[])
#include "createNamedPolyMesh.H" #include "createNamedPolyMesh.H"
const bool writeObj = args.optionFound("writeObj");
const word oldInstance = mesh.pointsInstance(); const word oldInstance = mesh.pointsInstance();
const word dictName("createPatchDict"); const word dictName("createPatchDict");
#include "setSystemMeshDictionaryIO.H" #include "setSystemMeshDictionaryIO.H"
Info<< "Reading " << dictIO.instance()/dictIO.name() << nl << endl;
Info<< "Reading " << dictName << nl << endl;
IOdictionary dict(dictIO); IOdictionary dict(dictIO);
@ -534,7 +540,10 @@ int main(int argc, char *argv[])
patches.checkParallelSync(true); patches.checkParallelSync(true);
dumpCyclicMatch("initial_", mesh); if (writeObj)
{
dumpCyclicMatch("initial_", mesh);
}
// Read patch construct info from dictionary // Read patch construct info from dictionary
PtrList<dictionary> patchSources(dict.lookup("patches")); PtrList<dictionary> patchSources(dict.lookup("patches"));
@ -753,7 +762,10 @@ int main(int argc, char *argv[])
autoPtr<mapPolyMesh> map = meshMod.changeMesh(mesh, true); autoPtr<mapPolyMesh> map = meshMod.changeMesh(mesh, true);
mesh.movePoints(map().preMotionPoints()); mesh.movePoints(map().preMotionPoints());
dumpCyclicMatch("coupled_", mesh); if (writeObj)
{
dumpCyclicMatch("coupled_", mesh);
}
// Synchronise points. // Synchronise points.
if (!pointSync) if (!pointSync)
@ -864,7 +876,10 @@ int main(int argc, char *argv[])
filterPatches(mesh, addedPatchNames); filterPatches(mesh, addedPatchNames);
dumpCyclicMatch("final_", mesh); if (writeObj)
{
dumpCyclicMatch("final_", mesh);
}
// Set the precision of the points data to 10 // Set the precision of the points data to 10

View File

@ -96,6 +96,8 @@ int main(int argc, char *argv[])
Info<< "Writing points into directory " << points.path() << nl << endl; Info<< "Writing points into directory " << points.path() << nl << endl;
points.write(); points.write();
Info<< nl << "End" << nl << endl;
return 0; return 0;
} }

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -62,7 +62,6 @@ int main(int argc, char *argv[])
"merge two meshes" "merge two meshes"
); );
argList::noParallel();
#include "addOverwriteOption.H" #include "addOverwriteOption.H"
argList::validArgs.append("masterCase"); argList::validArgs.append("masterCase");
@ -97,6 +96,18 @@ int main(int argc, char *argv[])
word addRegion = polyMesh::defaultRegion; word addRegion = polyMesh::defaultRegion;
args.optionReadIfPresent("addRegion", addRegion); args.optionReadIfPresent("addRegion", addRegion);
// Since we don't use argList processor directory detection, add it to
// the casename ourselves so it triggers the logic inside TimePath.
const fileName& cName = args.caseName();
std::string::size_type pos = cName.find("processor");
if (pos != string::npos && pos != 0)
{
fileName processorName = cName.substr(pos, cName.size()-pos);
masterCase += '/' + processorName;
addCase += '/' + processorName;
}
getRootCase(masterCase); getRootCase(masterCase);
getRootCase(addCase); getRootCase(addCase);

View File

@ -242,8 +242,6 @@ Foam::mirrorFvMesh::mirrorFvMesh(const IOobject& io)
} }
// Mirror boundary faces patch by patch // Mirror boundary faces patch by patch
labelList newToOldPatch(boundary().size(), -1); labelList newToOldPatch(boundary().size(), -1);
labelList newPatchSizes(boundary().size(), -1); labelList newPatchSizes(boundary().size(), -1);
labelList newPatchStarts(boundary().size(), -1); labelList newPatchStarts(boundary().size(), -1);

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