Thermodynamyics: rename basicThermo -> fluidThermo and veryBasicThermo -> basicThermo

This commit is contained in:
Henry
2012-08-23 14:13:13 +01:00
parent 26abc53885
commit 830c0ef382
179 changed files with 770 additions and 770 deletions

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/
#include "interRegionHeatTransferModel.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "fvm.H"
#include "IObasicSourceList.H"
#include "zeroGradientFvPatchFields.H"
@ -203,8 +203,8 @@ void Foam::interRegionHeatTransferModel::addSup
if (h.dimensions() == dimEnergy/dimMass)
{
const basicThermo& primaryThermo =
mesh_.lookupObject<basicThermo>("thermophysicalProperties");
const fluidThermo& primaryThermo =
mesh_.lookupObject<fluidThermo>("thermophysicalProperties");
eEqn += htc_*Tmapped - fvm::Sp(htc_/primaryThermo.Cp(), h);

View File

@ -108,8 +108,8 @@ calculateHtc()
"turbulenceModel"
);
const basicThermo& secondaryThermo =
secondaryMesh.lookupObject<basicThermo>
const fluidThermo& secondaryThermo =
secondaryMesh.lookupObject<fluidThermo>
(
"thermophysicalProperties"
);

View File

@ -27,7 +27,7 @@ LIB_LIBS = \
-llagrangianIntermediate \
-ldistributionModels \
-lspecie \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lliquidProperties \
-lliquidMixtureProperties \
-lsolidProperties \

View File

@ -25,7 +25,7 @@ $(KINEMATICCOLLIDINGPARCEL)/makeBasicKinematicCollidingParcelSubmodels.C
/* thermo parcel sub-models */
THERMOPARCEL=$(DERIVEDPARCELS)/basicThermoParcel
THERMOPARCEL=$(DERIVEDPARCELS)/fluidThermoParcel
$(THERMOPARCEL)/defineBasicThermoParcel.C
$(THERMOPARCEL)/makeBasicThermoParcelSubmodels.C

View File

@ -25,8 +25,8 @@ $(KINEMATICPARCEL)/defineBasicKinematicParcel.C
$(KINEMATICPARCEL)/makeBasicKinematicParcelSubmodels.C
/* thermo parcel sub-models */
THERMOPARCEL=$(DERIVEDPARCELS)/basicThermoParcel
$(THERMOPARCEL)/basicThermoParcel.C
THERMOPARCEL=$(DERIVEDPARCELS)/fluidThermoParcel
$(THERMOPARCEL)/fluidThermoParcel.C
$(THERMOPARCEL)/defineBasicThermoParcel.C
$(THERMOPARCEL)/makeBasicThermoParcelSubmodels.C

View File

@ -25,7 +25,7 @@ LIB_LIBS = \
-llagrangian \
-ldistributionModels \
-lspecie \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lliquidProperties \
-lliquidMixtureProperties \
-lsolidProperties \

View File

@ -22,18 +22,18 @@ License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
Class
Foam::basicThermoCloud
Foam::fluidThermoCloud
Description
Cloud class to introduce thermodynamic parcels
\*---------------------------------------------------------------------------*/
#ifndef basicThermoCloud_H
#define basicThermoCloud_H
#ifndef fluidThermoCloud_H
#define fluidThermoCloud_H
#include "ThermoCloud.H"
#include "basicThermoParcel.H"
#include "fluidThermoParcel.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -45,10 +45,10 @@ namespace Foam
<
Cloud
<
basicThermoParcel
fluidThermoParcel
>
>
> basicThermoCloud;
> fluidThermoCloud;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,15 +23,15 @@ License
\*---------------------------------------------------------------------------*/
#include "basicThermoParcel.H"
#include "fluidThermoParcel.H"
#include "Cloud.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
defineTemplateTypeNameAndDebug(basicThermoParcel, 0);
defineTemplateTypeNameAndDebug(Cloud<basicThermoParcel>, 0);
defineTemplateTypeNameAndDebug(fluidThermoParcel, 0);
defineTemplateTypeNameAndDebug(Cloud<fluidThermoParcel>, 0);
}
// ************************************************************************* //

View File

@ -22,18 +22,18 @@ License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
Class
Foam::basicThermoParcel
Foam::fluidThermoParcel
Description
Definition of basic thermo parcel
SourceFiles
basicThermoParcel.C
fluidThermoParcel.C
\*---------------------------------------------------------------------------*/
#ifndef basicThermoParcel_H
#define basicThermoParcel_H
#ifndef fluidThermoParcel_H
#define fluidThermoParcel_H
#include "contiguous.H"
#include "particle.H"
@ -44,10 +44,10 @@ SourceFiles
namespace Foam
{
typedef ThermoParcel<KinematicParcel<particle> > basicThermoParcel;
typedef ThermoParcel<KinematicParcel<particle> > fluidThermoParcel;
template<>
inline bool contiguous<basicThermoParcel>()
inline bool contiguous<fluidThermoParcel>()
{
return true;
}

View File

@ -23,7 +23,7 @@ License
\*---------------------------------------------------------------------------*/
#include "basicThermoCloud.H"
#include "fluidThermoCloud.H"
#include "makeParcelCloudFunctionObjects.H"
@ -41,17 +41,17 @@ License
namespace Foam
{
makeParcelCloudFunctionObjects(basicThermoCloud);
makeParcelCloudFunctionObjects(fluidThermoCloud);
// Kinematic sub-models
makeThermoParcelForces(basicThermoCloud);
makeParcelDispersionModels(basicThermoCloud);
makeParcelInjectionModels(basicThermoCloud);
makeParcelPatchInteractionModels(basicThermoCloud);
makeThermoParcelForces(fluidThermoCloud);
makeParcelDispersionModels(fluidThermoCloud);
makeParcelInjectionModels(fluidThermoCloud);
makeParcelPatchInteractionModels(fluidThermoCloud);
// Thermo sub-models
makeParcelHeatTransferModels(basicThermoCloud);
makeParcelSurfaceFilmModels(basicThermoCloud);
makeParcelHeatTransferModels(fluidThermoCloud);
makeParcelSurfaceFilmModels(fluidThermoCloud);
}

View File

@ -27,7 +27,7 @@ LIB_LIBS = \
-llagrangianIntermediate \
-ldistributionModels \
-lspecie \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lliquidProperties \
-lliquidMixtureProperties \
-lsolidProperties \

View File

@ -11,7 +11,7 @@ LIB_LIBS = \
-lincompressibleTransportModels \
-lincompressibleRASModels \
-lincompressibleLESModels \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lspecie \
-lcompressibleRASModels \
-lcompressibleLESModels \

View File

@ -33,7 +33,7 @@ License
#include "incompressible/RAS/RASModel/RASModel.H"
#include "incompressible/LES/LESModel/LESModel.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "compressible/RAS/RASModel/RASModel.H"
#include "compressible/LES/LESModel/LESModel.H"
@ -75,10 +75,10 @@ Foam::tmp<Foam::volSymmTensorField> Foam::forces::devRhoReff() const
return rho()*les.devReff();
}
else if (obr_.foundObject<basicThermo>("thermophysicalProperties"))
else if (obr_.foundObject<fluidThermo>("thermophysicalProperties"))
{
const basicThermo& thermo =
obr_.lookupObject<basicThermo>("thermophysicalProperties");
const fluidThermo& thermo =
obr_.lookupObject<fluidThermo>("thermophysicalProperties");
const volVectorField& U = obr_.lookupObject<volVectorField>(UName_);

View File

@ -22,4 +22,4 @@ LIB_LIBS = \
-lincompressibleRASModels \
-lcompressibleLESModels \
-lincompressibleLESModels \
-lbasicThermophysicalModels
-lfluidThermophysicalModels

View File

@ -21,7 +21,7 @@ LIB_LIBS = \
-lspecie \
-lspecie \
-lsolid \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lsolidChemistryModel \
-lcompressibleTurbulenceModel \
-lcompressibleRASModels \

View File

@ -19,7 +19,7 @@ EXE_INC = \
LIB_LIBS = \
-lfiniteVolume \
-lmeshTools \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lspecie \
-lliquidProperties \
-lliquidMixtureProperties \

View File

@ -38,7 +38,7 @@ Description
// Coupled BC.
neighbourFieldName T;
kappa basicThermo;
kappa fluidThermo;
KName none;

View File

@ -35,7 +35,7 @@ namespace Foam
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::SLGThermo::SLGThermo(const fvMesh& mesh, basicThermo& thermo)
Foam::SLGThermo::SLGThermo(const fvMesh& mesh, fluidThermo& thermo)
:
MeshObject<fvMesh, SLGThermo>(mesh),
thermo_(thermo),
@ -91,7 +91,7 @@ Foam::SLGThermo::~SLGThermo()
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
const Foam::basicThermo& Foam::SLGThermo::thermo() const
const Foam::fluidThermo& Foam::SLGThermo::thermo() const
{
return thermo_;
}

View File

@ -46,7 +46,7 @@ SourceFiles
#define SLGThermo_H
#include "MeshObject.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "basicMultiComponentMixture.H"
#include "liquidMixtureProperties.H"
#include "solidMixtureProperties.H"
@ -67,7 +67,7 @@ class SLGThermo
// Private data
//- Thermo package
basicThermo& thermo_;
fluidThermo& thermo_;
//- Reference to the multi-component carrier phase thermo
basicMultiComponentMixture* carrier_;
@ -87,7 +87,7 @@ public:
// Constructors
//- Construct from mesh
SLGThermo(const fvMesh& mesh, basicThermo& thermo);
SLGThermo(const fvMesh& mesh, fluidThermo& thermo);
//- Destructor
@ -99,7 +99,7 @@ public:
// Access
//- Return reference to the thermo database
const basicThermo& thermo() const;
const fluidThermo& thermo() const;
//- Return reference to the gaseous components
const basicMultiComponentMixture& carrier() const;

View File

@ -1,12 +1,12 @@
mixtures/basicMixture/basicMixture.C
mixtures/basicMixture/basicMixtures.C
basicThermo/veryBasicThermo.C
basicThermo/veryBasicThermoNew.C
basicThermo/basicThermo.C
basicThermo/basicThermoNew.C
fluidThermo/fluidThermo.C
fluidThermo/fluidThermoNew.C
psiThermo/psiThermo/psiThermo.C
psiThermo/psiThermo/psiThermoNew.C
psiThermo/hePsiThermo/hePsiThermos.C
@ -22,4 +22,4 @@ derivedFvPatchFields/energyJump/energyJumpFvPatchScalarField.C
derivedFvPatchFields/wallHeatTransfer/wallHeatTransferFvPatchScalarField.C
LIB = $(FOAM_LIBBIN)/libbasicThermophysicalModels
LIB = $(FOAM_LIBBIN)/libfluidThermophysicalModels

View File

@ -25,6 +25,7 @@ License
#include "basicThermo.H"
/* * * * * * * * * * * * * * * private static data * * * * * * * * * * * * * */
namespace Foam
@ -38,14 +39,119 @@ namespace Foam
Foam::basicThermo::basicThermo(const fvMesh& mesh)
:
veryBasicThermo(mesh)
IOdictionary
(
IOobject
(
"thermophysicalProperties",
mesh.time().constant(),
mesh,
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE
)
),
p_
(
IOobject
(
"p",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
T_
(
IOobject
(
"T",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
alpha_
(
IOobject
(
"alpha",
mesh.time().timeName(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh,
dimensionSet(1, -1, -1, 0, 0)
)
{}
Foam::basicThermo::basicThermo(const fvMesh& mesh, const dictionary& dict)
Foam::basicThermo::basicThermo
(
const fvMesh& mesh,
const dictionary& dict
)
:
veryBasicThermo(mesh, dict)
IOdictionary
(
IOobject
(
"thermophysicalProperties",
mesh.time().constant(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
dict
),
p_
(
IOobject
(
"p",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
T_
(
IOobject
(
"T",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
alpha_
(
IOobject
(
"alpha",
mesh.time().timeName(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh,
dimensionSet(1, -1, -1, 0, 0)
)
{}
@ -55,4 +161,36 @@ Foam::basicThermo::~basicThermo()
{}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
Foam::volScalarField& Foam::basicThermo::p()
{
return p_;
}
const Foam::volScalarField& Foam::basicThermo::p() const
{
return p_;
}
const Foam::volScalarField& Foam::basicThermo::T() const
{
return T_;
}
const Foam::volScalarField& Foam::basicThermo::alpha() const
{
return alpha_;
}
bool Foam::basicThermo::read()
{
return regIOobject::read();
}
// ************************************************************************* //

View File

@ -36,7 +36,10 @@ SourceFiles
#ifndef basicThermo_H
#define basicThermo_H
#include "veryBasicThermo.H"
#include "volFields.H"
#include "typeInfo.H"
#include "IOdictionary.H"
#include "autoPtr.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -49,9 +52,29 @@ namespace Foam
class basicThermo
:
public veryBasicThermo
public IOdictionary
{
protected:
// Protected data
// Fields
//- Pressure [Pa]
volScalarField p_;
//- Temperature [K]
volScalarField T_;
//- Laminar thermal diffusuvity [kg/m/s]
volScalarField alpha_;
//- Construct as copy (not implemented)
basicThermo(const basicThermo&);
public:
//- Runtime type information
@ -86,16 +109,174 @@ public:
// Member functions
//- Update properties
virtual void correct() = 0;
// Access to thermodynamic state variables
//- Compressibility [s^2/m^2]
virtual const volScalarField& psi() const = 0;
//- Pressure [Pa]
// Non-const access allowed for transport equations
virtual volScalarField& p();
//- Pressure [Pa]
virtual const volScalarField& p() const;
//- Density [kg/m^3]
virtual tmp<volScalarField> rho() const = 0;
//- Enthalpy/Internal energy [J/kg]
// Non-const access allowed for transport equations
virtual volScalarField& he() = 0;
//- Enthalpy/Internal energy [J/kg]
virtual const volScalarField& he() const = 0;
//- Enthalpy/Internal energy for cell-set [J/kg]
virtual tmp<scalarField> he
(
const scalarField& p,
const scalarField& T,
const labelList& cells
) const = 0;
//- Enthalpy/Internal energy for patch [J/kg]
virtual tmp<scalarField> he
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Chemical enthalpy [J/kg]
virtual tmp<volScalarField> hc() const = 0;
//- Temperature from enthalpy/internal energy for cell-set
virtual tmp<scalarField> THE
(
const scalarField& h,
const scalarField& p,
const scalarField& T0, // starting temperature
const labelList& cells
) const = 0;
//- Temperature from enthalpy/internal energy for patch
virtual tmp<scalarField> THE
(
const scalarField& h,
const scalarField& p,
const scalarField& T0, // starting temperature
const label patchi
) const = 0;
// Fields derived from thermodynamic state variables
//- Temperature [K]
virtual const volScalarField& T() const;
//- Heat capacity at constant pressure [J/kg/K]
virtual tmp<volScalarField> Cp() const = 0;
//- Heat capacity at constant pressure for patch [J/kg/K]
virtual tmp<scalarField> Cp
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Heat capacity at constant volume [J/kg/K]
virtual tmp<volScalarField> Cv() const = 0;
//- Heat capacity at constant volume for patch [J/kg/K]
virtual tmp<scalarField> Cv
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- gamma = Cp/Cv []
virtual tmp<volScalarField> gamma() const = 0;
//- gamma = Cp/Cv for patch []
virtual tmp<scalarField> gamma
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Heat capacity at constant pressure/volume [J/kg/K]
virtual tmp<volScalarField> Cpv() const = 0;
//- Heat capacity at constant pressure/volume for patch [J/kg/K]
virtual tmp<scalarField> Cpv
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Heat capacity ratio []
virtual tmp<volScalarField> CpByCpv() const = 0;
//- Heat capacity ratio for patch []
virtual tmp<scalarField> CpByCpv
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
// Access to transport state variables
//- Dynamic viscosity of mixture [kg/m/s]
virtual const volScalarField& mu() const = 0;
//- Thermal diffusivity for enthalpy of mixture [kg/m/s]
virtual const volScalarField& alpha() const;
// Fields derived from transport state variables
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
virtual tmp<volScalarField> kappa() const = 0;
//- Thermal diffusivity of mixture for patch [J/m/s/K]
virtual tmp<scalarField> kappa
(
const label patchi
) const = 0;
//- Effective thermal diffusivity of mixture [J/m/s/K]
virtual tmp<volScalarField> kappaEff
(
const volScalarField&
) const = 0;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
virtual tmp<scalarField> kappaEff
(
const scalarField& alphat,
const label patchi
) const = 0;
//- Effective thermal diffusivity of mixture [J/m/s/K]
virtual tmp<volScalarField> alphaEff
(
const volScalarField& alphat
) const = 0;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
virtual tmp<scalarField> alphaEff
(
const scalarField& alphat,
const label patchi
) const = 0;
//- Read thermophysicalProperties dictionary
virtual bool read();
};

View File

@ -1,196 +0,0 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2012 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/>.
\*---------------------------------------------------------------------------*/
#include "veryBasicThermo.H"
/* * * * * * * * * * * * * * * private static data * * * * * * * * * * * * * */
namespace Foam
{
defineTypeNameAndDebug(veryBasicThermo, 0);
defineRunTimeSelectionTable(veryBasicThermo, fvMesh);
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::veryBasicThermo::veryBasicThermo(const fvMesh& mesh)
:
IOdictionary
(
IOobject
(
"thermophysicalProperties",
mesh.time().constant(),
mesh,
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE
)
),
p_
(
IOobject
(
"p",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
T_
(
IOobject
(
"T",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
alpha_
(
IOobject
(
"alpha",
mesh.time().timeName(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh,
dimensionSet(1, -1, -1, 0, 0)
)
{}
Foam::veryBasicThermo::veryBasicThermo
(
const fvMesh& mesh,
const dictionary& dict
)
:
IOdictionary
(
IOobject
(
"thermophysicalProperties",
mesh.time().constant(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
dict
),
p_
(
IOobject
(
"p",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
T_
(
IOobject
(
"T",
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
mesh
),
alpha_
(
IOobject
(
"alpha",
mesh.time().timeName(),
mesh,
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh,
dimensionSet(1, -1, -1, 0, 0)
)
{}
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
Foam::veryBasicThermo::~veryBasicThermo()
{}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
Foam::volScalarField& Foam::veryBasicThermo::p()
{
return p_;
}
const Foam::volScalarField& Foam::veryBasicThermo::p() const
{
return p_;
}
const Foam::volScalarField& Foam::veryBasicThermo::T() const
{
return T_;
}
const Foam::volScalarField& Foam::veryBasicThermo::alpha() const
{
return alpha_;
}
bool Foam::veryBasicThermo::read()
{
return regIOobject::read();
}
// ************************************************************************* //

View File

@ -1,291 +0,0 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2012 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/>.
Class
Foam::veryBasicThermo
Description
Basic thermodynamic properties
SourceFiles
veryBasicThermo.C
veryBasicThermoNew.C
\*---------------------------------------------------------------------------*/
#ifndef veryBasicThermo_H
#define veryBasicThermo_H
#include "volFields.H"
#include "typeInfo.H"
#include "IOdictionary.H"
#include "autoPtr.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
/*---------------------------------------------------------------------------*\
Class veryBasicThermo Declaration
\*---------------------------------------------------------------------------*/
class veryBasicThermo
:
public IOdictionary
{
protected:
// Protected data
// Fields
//- Pressure [Pa]
volScalarField p_;
//- Temperature [K]
volScalarField T_;
//- Laminar thermal diffusuvity [kg/m/s]
volScalarField alpha_;
//- Construct as copy (not implemented)
veryBasicThermo(const veryBasicThermo&);
public:
//- Runtime type information
TypeName("veryBasicThermo");
//- Declare run-time constructor selection table
declareRunTimeSelectionTable
(
autoPtr,
veryBasicThermo,
fvMesh,
(const fvMesh& mesh),
(mesh)
);
// Constructors
//- Construct from mesh
veryBasicThermo(const fvMesh&);
//- Construct from mesh
veryBasicThermo(const fvMesh&, const dictionary&);
//- Selector
static autoPtr<veryBasicThermo> New(const fvMesh&);
//- Destructor
virtual ~veryBasicThermo();
// Member functions
//- Update properties
virtual void correct() = 0;
// Access to thermodynamic state variables
//- Pressure [Pa]
// Non-const access allowed for transport equations
virtual volScalarField& p();
//- Pressure [Pa]
virtual const volScalarField& p() const;
//- Density [kg/m^3]
virtual tmp<volScalarField> rho() const = 0;
//- Enthalpy/Internal energy [J/kg]
// Non-const access allowed for transport equations
virtual volScalarField& he() = 0;
//- Enthalpy/Internal energy [J/kg]
virtual const volScalarField& he() const = 0;
//- Enthalpy/Internal energy for cell-set [J/kg]
virtual tmp<scalarField> he
(
const scalarField& p,
const scalarField& T,
const labelList& cells
) const = 0;
//- Enthalpy/Internal energy for patch [J/kg]
virtual tmp<scalarField> he
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Chemical enthalpy [J/kg]
virtual tmp<volScalarField> hc() const = 0;
//- Temperature from enthalpy/internal energy for cell-set
virtual tmp<scalarField> THE
(
const scalarField& h,
const scalarField& p,
const scalarField& T0, // starting temperature
const labelList& cells
) const = 0;
//- Temperature from enthalpy/internal energy for patch
virtual tmp<scalarField> THE
(
const scalarField& h,
const scalarField& p,
const scalarField& T0, // starting temperature
const label patchi
) const = 0;
// Fields derived from thermodynamic state variables
//- Temperature [K]
virtual const volScalarField& T() const;
//- Heat capacity at constant pressure [J/kg/K]
virtual tmp<volScalarField> Cp() const = 0;
//- Heat capacity at constant pressure for patch [J/kg/K]
virtual tmp<scalarField> Cp
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Heat capacity at constant volume [J/kg/K]
virtual tmp<volScalarField> Cv() const = 0;
//- Heat capacity at constant volume for patch [J/kg/K]
virtual tmp<scalarField> Cv
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- gamma = Cp/Cv []
virtual tmp<volScalarField> gamma() const = 0;
//- gamma = Cp/Cv for patch []
virtual tmp<scalarField> gamma
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Heat capacity at constant pressure/volume [J/kg/K]
virtual tmp<volScalarField> Cpv() const = 0;
//- Heat capacity at constant pressure/volume for patch [J/kg/K]
virtual tmp<scalarField> Cpv
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
//- Heat capacity ratio []
virtual tmp<volScalarField> CpByCpv() const = 0;
//- Heat capacity ratio for patch []
virtual tmp<scalarField> CpByCpv
(
const scalarField& p,
const scalarField& T,
const label patchi
) const = 0;
// Access to transport state variables
//- Thermal diffusivity for enthalpy of mixture [kg/m/s]
virtual const volScalarField& alpha() const;
// Fields derived from transport state variables
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
virtual tmp<volScalarField> kappa() const = 0;
//- Thermal diffusivity of mixture for patch [J/m/s/K]
virtual tmp<scalarField> kappa
(
const label patchi
) const = 0;
//- Effective thermal diffusivity of mixture [J/m/s/K]
virtual tmp<volScalarField> kappaEff
(
const volScalarField&
) const = 0;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
virtual tmp<scalarField> kappaEff
(
const scalarField& alphat,
const label patchi
) const = 0;
//- Effective thermal diffusivity of mixture [J/m/s/K]
virtual tmp<volScalarField> alphaEff
(
const volScalarField& alphat
) const = 0;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
virtual tmp<scalarField> alphaEff
(
const scalarField& alphat,
const label patchi
) const = 0;
//- Read thermophysicalProperties dictionary
virtual bool read();
};
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#endif
// ************************************************************************* //

View File

@ -26,7 +26,7 @@ License
#include "addToRunTimeSelectionTable.H"
#include "energyJumpFvPatchScalarField.H"
#include "temperatureJumpFvPatchScalarField.H"
#include "veryBasicThermo.H"
#include "basicThermo.H"
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -103,7 +103,7 @@ void Foam::energyJumpFvPatchScalarField::updateCoeffs()
if (this->cyclicPatch().owner())
{
const veryBasicThermo& thermo = db().lookupObject<veryBasicThermo>
const basicThermo& thermo = db().lookupObject<basicThermo>
(
"thermophysicalProperties"
);

View File

@ -25,7 +25,7 @@ License
#include "fvPatchFieldMapper.H"
#include "volFields.H"
#include "veryBasicThermo.H"
#include "basicThermo.H"
#include "addToRunTimeSelectionTable.H"
#include "fixedEnergyFvPatchScalarField.H"
@ -97,7 +97,7 @@ void Foam::fixedEnergyFvPatchScalarField::updateCoeffs()
return;
}
const veryBasicThermo& thermo = db().lookupObject<veryBasicThermo>
const basicThermo& thermo = db().lookupObject<basicThermo>
(
"thermophysicalProperties"
);

View File

@ -27,7 +27,7 @@ License
#include "addToRunTimeSelectionTable.H"
#include "fvPatchFieldMapper.H"
#include "volFields.H"
#include "veryBasicThermo.H"
#include "basicThermo.H"
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -97,7 +97,7 @@ void Foam::gradientEnergyFvPatchScalarField::updateCoeffs()
return;
}
const veryBasicThermo& thermo = db().lookupObject<veryBasicThermo>
const basicThermo& thermo = db().lookupObject<basicThermo>
(
"thermophysicalProperties"
);

View File

@ -27,7 +27,7 @@ License
#include "addToRunTimeSelectionTable.H"
#include "fvPatchFieldMapper.H"
#include "volFields.H"
#include "veryBasicThermo.H"
#include "basicThermo.H"
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -102,7 +102,7 @@ void Foam::mixedEnergyFvPatchScalarField::updateCoeffs()
return;
}
const veryBasicThermo& thermo = db().lookupObject<veryBasicThermo>
const basicThermo& thermo = db().lookupObject<basicThermo>
(
"thermophysicalProperties"
);

View File

@ -27,7 +27,7 @@ License
#include "addToRunTimeSelectionTable.H"
#include "fvPatchFieldMapper.H"
#include "volFields.H"
#include "veryBasicThermo.H"
#include "basicThermo.H"
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -149,7 +149,7 @@ void Foam::wallHeatTransferFvPatchScalarField::updateCoeffs()
return;
}
const veryBasicThermo& thermo = db().lookupObject<veryBasicThermo>
const basicThermo& thermo = db().lookupObject<basicThermo>
(
"thermophysicalProperties"
);

View File

@ -0,0 +1,58 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2012 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/>.
\*---------------------------------------------------------------------------*/
#include "fluidThermo.H"
/* * * * * * * * * * * * * * * private static data * * * * * * * * * * * * * */
namespace Foam
{
defineTypeNameAndDebug(fluidThermo, 0);
defineRunTimeSelectionTable(fluidThermo, fvMesh);
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::fluidThermo::fluidThermo(const fvMesh& mesh)
:
basicThermo(mesh)
{}
Foam::fluidThermo::fluidThermo(const fvMesh& mesh, const dictionary& dict)
:
basicThermo(mesh, dict)
{}
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
Foam::fluidThermo::~fluidThermo()
{}
// ************************************************************************* //

View File

@ -0,0 +1,110 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2012 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/>.
Class
Foam::fluidThermo
Description
Basic thermodynamic properties
SourceFiles
fluidThermo.C
fluidThermoNew.C
\*---------------------------------------------------------------------------*/
#ifndef fluidThermo_H
#define fluidThermo_H
#include "basicThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
/*---------------------------------------------------------------------------*\
Class fluidThermo Declaration
\*---------------------------------------------------------------------------*/
class fluidThermo
:
public basicThermo
{
public:
//- Runtime type information
TypeName("fluidThermo");
//- Declare run-time constructor selection table
declareRunTimeSelectionTable
(
autoPtr,
fluidThermo,
fvMesh,
(const fvMesh& mesh),
(mesh)
);
// Constructors
//- Construct from mesh
fluidThermo(const fvMesh&);
//- Construct from mesh
fluidThermo(const fvMesh&, const dictionary&);
//- Selector
static autoPtr<fluidThermo> New(const fvMesh&);
//- Destructor
virtual ~fluidThermo();
// Member functions
// Access to thermodynamic state variables
//- Compressibility [s^2/m^2]
virtual const volScalarField& psi() const = 0;
// Access to transport state variables
//- Dynamic viscosity of mixture [kg/m/s]
virtual const volScalarField& mu() const = 0;
};
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#endif
// ************************************************************************* //

View File

@ -23,11 +23,11 @@ License
\*---------------------------------------------------------------------------*/
#include "veryBasicThermo.H"
#include "fluidThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
Foam::autoPtr<Foam::veryBasicThermo> Foam::veryBasicThermo::New
Foam::autoPtr<Foam::fluidThermo> Foam::fluidThermo::New
(
const fvMesh& mesh
)
@ -57,14 +57,14 @@ Foam::autoPtr<Foam::veryBasicThermo> Foam::veryBasicThermo::New
if (cstrIter == fvMeshConstructorTablePtr_->end())
{
FatalErrorIn("veryBasicThermo::New(const fvMesh&)")
<< "Unknown veryBasicThermo type " << modelType << nl << nl
<< "Valid veryBasicThermo types are:" << nl
FatalErrorIn("fluidThermo::New(const fvMesh&)")
<< "Unknown fluidThermo type " << modelType << nl << nl
<< "Valid fluidThermo types are:" << nl
<< fvMeshConstructorTablePtr_->sortedToc() << nl
<< exit(FatalError);
}
return autoPtr<veryBasicThermo>(cstrIter()(mesh));
return autoPtr<fluidThermo>(cstrIter()(mesh));
}

View File

@ -22,7 +22,7 @@ License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
InClass
Foam::basicThermo
Foam::fluidThermo
Description
Macros for creating 'basic' density-based thermo packages
@ -83,7 +83,7 @@ addToRunTimeSelectionTable \
\
addToRunTimeSelectionTable \
( \
basicThermo, \
fluidThermo, \
Cthermo##Mixture##Transport##Type##Thermo##EqnOfState, \
fvMesh \
);
@ -124,7 +124,7 @@ addToRunTimeSelectionTable \
\
addToRunTimeSelectionTable \
( \
basicThermo, \
fluidThermo, \
Cthermo##Mixture##icoPoly##Order##Type##ThermoPhysics, \
fvMesh \
);

View File

@ -38,7 +38,7 @@ namespace Foam
Foam::psiThermo::psiThermo(const fvMesh& mesh)
:
basicThermo(mesh),
fluidThermo(mesh),
psi_
(

View File

@ -36,7 +36,7 @@ SourceFiles
#ifndef psiThermo_H
#define psiThermo_H
#include "basicThermo.H"
#include "fluidThermo.H"
#include "runTimeSelectionTables.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -50,7 +50,7 @@ namespace Foam
class psiThermo
:
public basicThermo
public fluidThermo
{
protected:

View File

@ -38,7 +38,7 @@ namespace Foam
Foam::rhoThermo::rhoThermo(const fvMesh& mesh)
:
basicThermo(mesh),
fluidThermo(mesh),
rho_
(
IOobject
@ -85,7 +85,7 @@ Foam::rhoThermo::rhoThermo(const fvMesh& mesh)
Foam::rhoThermo::rhoThermo(const fvMesh& mesh, const dictionary& dict)
:
basicThermo(mesh, dict),
fluidThermo(mesh, dict),
rho_
(
IOobject

View File

@ -36,7 +36,7 @@ SourceFiles
#ifndef rhoThermo_H
#define rhoThermo_H
#include "basicThermo.H"
#include "fluidThermo.H"
#include "runTimeSelectionTables.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -50,7 +50,7 @@ namespace Foam
class rhoThermo
:
public basicThermo
public fluidThermo
{
protected:

View File

@ -9,7 +9,7 @@ EXE_INC = \
-I$(LIB_SRC)/ODE/lnInclude
LIB_LIBS = \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lreactionThermophysicalModels \
-lspecie \
-lthermophysicalFunctions \

View File

@ -14,7 +14,7 @@ EXE_INC = \
LIB_LIBS = \
-lfiniteVolume \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lspecie \
-lsolidThermo \
-lmeshTools \

View File

@ -142,7 +142,7 @@ void Foam::radiation::radiationModel::correct()
Foam::tmp<Foam::fvScalarMatrix> Foam::radiation::radiationModel::Sh
(
basicThermo& thermo
fluidThermo& thermo
) const
{
volScalarField& he = thermo.he();

View File

@ -45,7 +45,7 @@ SourceFiles
#include "autoPtr.H"
#include "runTimeSelectionTables.H"
#include "volFields.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "fvMatrices.H"
#include "blackBodyEmission.H"
@ -177,7 +177,7 @@ public:
virtual tmp<DimensionedField<scalar, volMesh> > Ru() const = 0;
//- Energy source term
virtual tmp<fvScalarMatrix> Sh(basicThermo& thermo) const;
virtual tmp<fvScalarMatrix> Sh(fluidThermo& thermo) const;
};

View File

@ -60,7 +60,7 @@ Foam::radiation::greyMeanAbsorptionEmission::greyMeanAbsorptionEmission
speciesNames_(0),
specieIndex_(label(0)),
lookUpTablePtr_(),
thermo_(mesh.lookupObject<basicThermo>("thermophysicalProperties")),
thermo_(mesh.lookupObject<fluidThermo>("thermophysicalProperties")),
EhrrCoeff_(readScalar(coeffsDict_.lookup("EhrrCoeff"))),
Yj_(nSpecies_)
{

View File

@ -89,7 +89,7 @@ SourceFiles
#include "absorptionEmissionModel.H"
#include "HashTable.H"
#include "absorptionCoeffs.H"
#include "basicThermo.H"
#include "fluidThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -134,7 +134,7 @@ private:
mutable autoPtr<interpolationLookUpTable<scalar> > lookUpTablePtr_;
//- SLG thermo package
const basicThermo& thermo_;
const fluidThermo& thermo_;
//- Emission constant coefficient
const scalar EhrrCoeff_;

View File

@ -62,7 +62,7 @@ Foam::radiation::wideBandAbsorptionEmission::wideBandAbsorptionEmission
mesh.time().constant(),
mesh
),
thermo_(mesh.lookupObject<basicThermo>("thermophysicalProperties")),
thermo_(mesh.lookupObject<fluidThermo>("thermophysicalProperties")),
Yj_(nSpecies_),
totalWaveLength_(0)
{

View File

@ -106,7 +106,7 @@ SourceFiles
#include "absorptionEmissionModel.H"
#include "HashTable.H"
#include "absorptionCoeffs.H"
#include "basicThermo.H"
#include "fluidThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -160,7 +160,7 @@ private:
mutable interpolationLookUpTable<scalar> lookUpTable_;
//- Thermo package
const basicThermo& thermo_;
const fluidThermo& thermo_;
//- Bands
label nBands_;

View File

@ -10,4 +10,4 @@ LIB_LIBS = \
-lfiniteVolume \
-lspecie \
-lsolidSpecie \
-lbasicThermophysicalModels
-lfluidThermophysicalModels

View File

@ -33,7 +33,7 @@ Description
#define makesolidThermo_H
#include "addToRunTimeSelectionTable.H"
#include "veryBasicThermo.H"
#include "basicThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
@ -131,7 +131,7 @@ addToRunTimeSelectionTable \
); \
addToRunTimeSelectionTable \
( \
veryBasicThermo, \
basicThermo, \
Cthermo##Mixture##Transport##Radiation##Type##Thermo##Rho##BaseThermo, \
fvMesh \
); \

View File

@ -41,7 +41,7 @@ namespace Foam
Foam::solidThermo::solidThermo(const fvMesh& mesh)
:
veryBasicThermo(mesh),
basicThermo(mesh),
rho_
(
IOobject
@ -64,7 +64,7 @@ Foam::solidThermo::solidThermo
const dictionary& dict
)
:
veryBasicThermo(mesh, dict),
basicThermo(mesh, dict),
rho_
(
IOobject

View File

@ -41,7 +41,7 @@ SourceFiles
#include "IOdictionary.H"
#include "autoPtr.H"
#include "basicSolidMixture.H"
#include "veryBasicThermo.H"
#include "basicThermo.H"
#include "autoPtr.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -55,7 +55,7 @@ namespace Foam
class solidThermo
:
public veryBasicThermo
public basicThermo
{
protected:

View File

@ -4,6 +4,6 @@ EXE_INC = \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude
LIB_LIBS = \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lmeshTools \
-lfiniteVolume

View File

@ -25,7 +25,7 @@ License
#include "fixedTemperature.H"
#include "addToRunTimeSelectionTable.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "volFields.H"
#include "fvMatrices.H"
@ -66,7 +66,7 @@ Foam::porousMedia::fixedTemperature::~fixedTemperature()
void Foam::porousMedia::fixedTemperature::addEnergySource
(
const basicThermo& thermo,
const fluidThermo& thermo,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const

View File

@ -80,7 +80,7 @@ public:
//- Add the thermal source to the enthalpy equation
virtual void addEnergySource
(
const basicThermo&,
const fluidThermo&,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const;

View File

@ -25,7 +25,7 @@ License
#include "noThermalModel.H"
#include "addToRunTimeSelectionTable.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "volFields.H"
#include "fvMatrices.H"
@ -65,7 +65,7 @@ Foam::porousMedia::noThermalModel::~noThermalModel()
void Foam::porousMedia::noThermalModel::addEnergySource
(
const basicThermo&,
const fluidThermo&,
const volScalarField&,
fvScalarMatrix&
) const

View File

@ -72,7 +72,7 @@ public:
//- Add the thermal source to the enthalpy equation
virtual void addEnergySource
(
const basicThermo&,
const fluidThermo&,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const;

View File

@ -44,7 +44,7 @@ namespace Foam
{
// Forward declaration of classes
class basicThermo;
class fluidThermo;
namespace porousMedia
{
@ -107,7 +107,7 @@ public:
//- Add the thermal source to the enthalpy equation
virtual void addEnergySource
(
const basicThermo&,
const fluidThermo&,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const = 0;

View File

@ -24,7 +24,7 @@ License
\*----------------------------------------------------------------------------*/
#include "thermalPorousZone.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "volFields.H"
#include "fvMatrices.H"
@ -46,7 +46,7 @@ Foam::thermalPorousZone::thermalPorousZone
void Foam::thermalPorousZone::addEnergySource
(
const basicThermo& thermo,
const fluidThermo& thermo,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const

View File

@ -49,7 +49,7 @@ namespace Foam
{
class fvMesh;
class basicThermo;
class fluidThermo;
/*---------------------------------------------------------------------------*\
Class thermalPorousZone Declaration
@ -127,7 +127,7 @@ public:
//- Add the thermal source to the enthalpy equation
void addEnergySource
(
const basicThermo&,
const fluidThermo&,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const;

View File

@ -48,7 +48,7 @@ Foam::thermalPorousZones::thermalPorousZones
void Foam::thermalPorousZones::addEnergySource
(
const basicThermo& thermo,
const fluidThermo& thermo,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const

View File

@ -95,7 +95,7 @@ public:
//- Add the thermal source to the enthalpy equation
void addEnergySource
(
const basicThermo&,
const fluidThermo&,
const volScalarField& rho,
fvScalarMatrix& hEqn
) const;

View File

@ -60,7 +60,7 @@ DeardorffDiffStress::DeardorffDiffStress
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -104,7 +104,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -46,7 +46,7 @@ GenEddyVisc::GenEddyVisc
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -92,7 +92,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -46,7 +46,7 @@ GenSGSStress::GenSGSStress
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -93,7 +93,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -58,7 +58,7 @@ LESModel::LESModel
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName
)
:
@ -98,7 +98,7 @@ autoPtr<LESModel> LESModel::New
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName
)
{
@ -134,7 +134,7 @@ autoPtr<LESModel> LESModel::New
"const volScalarField&, "
"const volVectorField&, "
"const surfaceScalarField&, "
"const basicThermo&, "
"const fluidThermo&, "
"const word&"
")"
) << "Unknown LESModel type "

View File

@ -53,7 +53,7 @@ SourceFiles
#include "fvm.H"
#include "fvc.H"
#include "fvMatrices.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "bound.H"
#include "autoPtr.H"
#include "runTimeSelectionTables.H"
@ -121,7 +121,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName
),
(rho, U, phi, thermoPhysicalModel, turbulenceModelName)
@ -137,7 +137,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName
);
@ -150,7 +150,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName
);

View File

@ -68,7 +68,7 @@ Smagorinsky::Smagorinsky
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -96,7 +96,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -113,7 +113,7 @@ SpalartAllmaras::SpalartAllmaras
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -111,7 +111,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -105,7 +105,7 @@ homogeneousDynOneEqEddy::homogeneousDynOneEqEddy
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -109,7 +109,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -63,7 +63,7 @@ lowReOneEqEddy::lowReOneEqEddy
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -100,7 +100,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -59,7 +59,7 @@ oneEqEddy::oneEqEddy
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -104,7 +104,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -50,7 +50,7 @@ LRR::LRR
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -119,7 +119,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -50,7 +50,7 @@ LaunderGibsonRSTM::LaunderGibsonRSTM
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)
@ -253,7 +253,7 @@ LaunderGibsonRSTM::LaunderGibsonRSTM
(
"LaunderGibsonRSTM::LaunderGibsonRSTM"
"(const volScalarField&, const volVectorField&"
", const surfaceScalarField&, basicThermo&)"
", const surfaceScalarField&, fluidThermo&)"
) << "couplingFactor = " << couplingFactor_
<< " is not in range 0 - 1" << nl
<< exit(FatalError);

View File

@ -128,7 +128,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -65,7 +65,7 @@ LaunderSharmaKE::LaunderSharmaKE
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -112,7 +112,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -8,6 +8,6 @@ EXE_INC = \
LIB_LIBS = \
-lcompressibleTurbulenceModel \
-lfiniteVolume \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lspecie \
-lmeshTools

View File

@ -59,7 +59,7 @@ RASModel::RASModel
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName
)
:
@ -102,7 +102,7 @@ autoPtr<RASModel> RASModel::New
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName
)
{
@ -138,7 +138,7 @@ autoPtr<RASModel> RASModel::New
"const volScalarField&, "
"const volVectorField&, "
"const surfaceScalarField&, "
"basicThermo&, "
"fluidThermo&, "
"const word&"
")"
) << "Unknown RASModel type "

View File

@ -49,7 +49,7 @@ SourceFiles
#include "fvm.H"
#include "fvc.H"
#include "fvMatrices.H"
#include "basicThermo.H"
#include "fluidThermo.H"
#include "IOdictionary.H"
#include "Switch.H"
#include "bound.H"
@ -130,7 +130,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName
),
(rho, U, phi, thermoPhysicalModel, turbulenceModelName)
@ -146,7 +146,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName
);
@ -159,7 +159,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermoPhysicalModel,
const fluidThermo& thermoPhysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName
);

View File

@ -49,7 +49,7 @@ RNGkEpsilon::RNGkEpsilon
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -108,7 +108,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -116,7 +116,7 @@ SpalartAllmaras::SpalartAllmaras
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -149,7 +149,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -49,7 +49,7 @@ kEpsilon::kEpsilon
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -104,7 +104,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -92,7 +92,7 @@ kOmegaSST::kOmegaSST
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -187,7 +187,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -47,7 +47,7 @@ laminar::laminar
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -68,7 +68,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -94,7 +94,7 @@ realizableKE::realizableKE
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName,
const word& modelName
)

View File

@ -126,7 +126,7 @@ public:
const volScalarField& rho,
const volVectorField& U,
const surfaceScalarField& phi,
const basicThermo& thermophysicalModel,
const fluidThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName,
const word& modelName = typeName
);

View File

@ -9,7 +9,7 @@ EXE_INC = \
LIB_LIBS = \
-lsolidThermo \
-lbasicThermophysicalModels \
-lfluidThermophysicalModels \
-lspecie \
-lfiniteVolume \
-lmeshTools \

View File

@ -27,7 +27,7 @@ License
#include "volFields.H"
#include "solidThermo.H"
#include "turbulenceModel.H"
#include "basicThermo.H"
#include "fluidThermo.H"
// * * * * * * * * * * * * * Static Member Data * * * * * * * * * * * * * * //
@ -40,7 +40,7 @@ namespace Foam
4
>::names[] =
{
"basicThermo",
"fluidThermo",
"solidThermo",
"directionalSolidThermo",
"lookup"

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