Merge remote branch 'OpenCFD/master' into olesenm

This commit is contained in:
Mark Olesen
2010-10-15 16:23:41 +02:00
323 changed files with 5724 additions and 6561 deletions

View File

@ -34,17 +34,14 @@ Description
if (mesh.nInternalFaces()) if (mesh.nInternalFaces())
{ {
surfaceScalarField SfUfbyDelta = scalarField sumPhi =
mesh.surfaceInterpolation::deltaCoeffs() fvc::surfaceSum(mag(phiSt))().internalField()
*mag(phiSt/fvc::interpolate(rho)); /rho.internalField();
StCoNum = StCoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
max(SfUfbyDelta/mesh.magSf()).value()
*runTime.deltaTValue();
meanStCoNum = meanStCoNum =
(sum(SfUfbyDelta)/sum(mesh.magSf())).value() 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
*runTime.deltaTValue();
} }
Info<< "St courant Number mean: " << meanStCoNum Info<< "St courant Number mean: " << meanStCoNum

View File

@ -30,10 +30,10 @@ Description
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
{ {
scalar sumLocalContErr = runTime.deltaT().value()* scalar sumLocalContErr = runTime.deltaTValue()*
mag(fvc::div(phia))().weightedAverage(mesh.V()).value(); mag(fvc::div(phia))().weightedAverage(mesh.V()).value();
scalar globalContErr = runTime.deltaT().value()* scalar globalContErr = runTime.deltaTValue()*
fvc::div(phia)().weightedAverage(mesh.V()).value(); fvc::div(phia)().weightedAverage(mesh.V()).value();
cumulativeContErr += globalContErr; cumulativeContErr += globalContErr;

View File

@ -36,23 +36,23 @@ scalar waveCoNum = 0.0;
if (mesh.nInternalFaces()) if (mesh.nInternalFaces())
{ {
surfaceScalarField SfUfbyDelta = scalarField sumPhi =
mesh.surfaceInterpolation::deltaCoeffs() fvc::surfaceSum(mag(phi))().internalField()
*mag(phi)/fvc::interpolate(h); /h.internalField();
CoNum = max(SfUfbyDelta/mesh.magSf()) CoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
.value()*runTime.deltaTValue();
meanCoNum = (sum(SfUfbyDelta)/sum(mesh.magSf())) meanCoNum =
.value()*runTime.deltaTValue(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
// Gravity wave Courant number // Gravity wave Courant number
waveCoNum = waveCoNum = 0.25*gMax
0.5*max
( (
mesh.surfaceInterpolation::deltaCoeffs() fvc::surfaceSum
*sqrt(fvc::interpolate(h)) (
).value()*sqrt(magg).value()*runTime.deltaTValue(); fvc::interpolate(sqrt(h))*mesh.magSf()
)().internalField()/mesh.V().field()
)*sqrt(magg).value()*runTime.deltaTValue();
} }
Info<< "Courant number mean: " << meanCoNum Info<< "Courant number mean: " << meanCoNum

View File

@ -35,19 +35,21 @@ scalar acousticCoNum = 0.0;
if (mesh.nInternalFaces()) if (mesh.nInternalFaces())
{ {
surfaceScalarField SfUfbyDelta = scalarField sumPhi =
mesh.surfaceInterpolation::deltaCoeffs()*mag(phiv); fvc::surfaceSum(mag(phiv))().internalField();
CoNum = max(SfUfbyDelta/mesh.magSf()) CoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
.value()*runTime.deltaTValue();
meanCoNum = (sum(SfUfbyDelta)/sum(mesh.magSf())) meanCoNum =
.value()*runTime.deltaTValue(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
acousticCoNum = max acousticCoNum = 0.5*gMax
( (
mesh.surfaceInterpolation::deltaCoeffs()/sqrt(fvc::interpolate(psi)) fvc::surfaceSum
).value()*runTime.deltaTValue(); (
fvc::interpolate(scalar(1)/sqrt(psi))*mesh.magSf()
)().internalField()/mesh.V().field()
)*runTime.deltaTValue();
} }
Info<< "phiv Courant Number mean: " << meanCoNum Info<< "phiv Courant Number mean: " << meanCoNum

View File

@ -86,7 +86,7 @@ int main(int argc, char *argv[])
<< nl << endl; << nl << endl;
} }
Info<< "\n end \n"; Info<< "End\n" << endl;
return 0; return 0;
} }

View File

@ -43,10 +43,10 @@ if (mesh.nInternalFaces())
pos(alpha1 - 0.01)*pos(0.99 - alpha1) pos(alpha1 - 0.01)*pos(0.99 - alpha1)
*fvc::surfaceSum(mag(phi))().internalField(); *fvc::surfaceSum(mag(phi))().internalField();
alphaCoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaT().value(); alphaCoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
meanAlphaCoNum = meanAlphaCoNum =
0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaT().value(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
} }
Info<< "Interface Courant Number mean: " << meanAlphaCoNum Info<< "Interface Courant Number mean: " << meanAlphaCoNum

View File

@ -42,12 +42,12 @@ if (adjustTimeStep)
( (
min min
( (
deltaTFact*runTime.deltaT().value(), deltaTFact*runTime.deltaTValue(),
maxDeltaT maxDeltaT
) )
); );
Info<< "deltaT = " << runTime.deltaT().value() << endl; Info<< "deltaT = " << runTime.deltaTValue() << endl;
} }
// ************************************************************************* // // ************************************************************************* //

View File

@ -39,20 +39,16 @@ scalar meanAlphaCoNum = 0.0;
if (mesh.nInternalFaces()) if (mesh.nInternalFaces())
{ {
surfaceScalarField alpha1f = fvc::interpolate(alpha1); scalarField sumPhi = max
surfaceScalarField alpha2f = fvc::interpolate(alpha2);
surfaceScalarField SfUfbyDelta = max
( (
pos(alpha1f - 0.01)*pos(0.99 - alpha1f), pos(alpha1 - 0.01)*pos(0.99 - alpha1),
pos(alpha2f - 0.01)*pos(0.99 - alpha2f) pos(alpha2 - 0.01)*pos(0.99 - alpha2)
)*mesh.surfaceInterpolation::deltaCoeffs()*mag(phi); )*fvc::surfaceSum(mag(phi))().internalField();
alphaCoNum = max(SfUfbyDelta/mesh.magSf()) alphaCoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
.value()*runTime.deltaT().value();
meanAlphaCoNum = (sum(SfUfbyDelta)/sum(mesh.magSf())) meanAlphaCoNum =
.value()*runTime.deltaT().value(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
} }
Info<< "Interface Courant Number mean: " << meanAlphaCoNum Info<< "Interface Courant Number mean: " << meanAlphaCoNum

View File

@ -39,15 +39,14 @@ scalar meanAlphaCoNum = 0.0;
if (mesh.nInternalFaces()) if (mesh.nInternalFaces())
{ {
surfaceScalarField SfUfbyDelta = scalarField sumPhi =
mixture.nearInterface() mixture.nearInterface()().internalField()
*mesh.surfaceInterpolation::deltaCoeffs()*mag(phi); *fvc::surfaceSum(mag(phi))().internalField();
alphaCoNum = max(SfUfbyDelta/mesh.magSf()) alphaCoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
.value()*runTime.deltaT().value();
meanAlphaCoNum = (sum(SfUfbyDelta)/sum(mesh.magSf())) meanAlphaCoNum =
.value()*runTime.deltaT().value(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
} }
Info<< "Interface Courant Number mean: " << meanAlphaCoNum Info<< "Interface Courant Number mean: " << meanAlphaCoNum

View File

@ -457,12 +457,12 @@ Foam::tmp<Foam::volScalarField> Foam::multiphaseMixture::K
} }
Foam::tmp<Foam::surfaceScalarField> Foam::tmp<Foam::volScalarField>
Foam::multiphaseMixture::nearInterface() const Foam::multiphaseMixture::nearInterface() const
{ {
tmp<surfaceScalarField> tnearInt tmp<volScalarField> tnearInt
( (
new surfaceScalarField new volScalarField
( (
IOobject IOobject
( (
@ -477,8 +477,7 @@ Foam::multiphaseMixture::nearInterface() const
forAllConstIter(PtrDictionary<phase>, phases_, iter) forAllConstIter(PtrDictionary<phase>, phases_, iter)
{ {
surfaceScalarField alphaf = fvc::interpolate(iter()); tnearInt() = max(tnearInt(), pos(iter() - 0.01)*pos(0.99 - iter()));
tnearInt() = max(tnearInt(), pos(alphaf - 0.01)*pos(0.99 - alphaf));
} }
return tnearInt; return tnearInt;

View File

@ -258,7 +258,7 @@ public:
//- Indicator of the proximity of the interface //- Indicator of the proximity of the interface
// Field values are 1 near and 0 away for the interface. // Field values are 1 near and 0 away for the interface.
tmp<surfaceScalarField> nearInterface() const; tmp<volScalarField> nearInterface() const;
//- Solve for the mixture phase-fractions //- Solve for the mixture phase-fractions
void solve(); void solve();

View File

@ -1,11 +1,10 @@
# include "CourantNo.H" # include "CourantNo.H"
{ {
scalar UrCoNum = max scalar UrCoNum = 0.5*gMax
( (
mesh.surfaceInterpolation::deltaCoeffs()*mag(phia - phib) fvc::surfaceSum(mag(phia - phib))().internalField()/mesh.V().field()
/mesh.magSf() )*runTime.deltaTValue();
).value()*runTime.deltaT().value();
Info<< "Max Ur Courant Number = " << UrCoNum << endl; Info<< "Max Ur Courant Number = " << UrCoNum << endl;

View File

@ -11,7 +11,7 @@ EXE_INC = \
EXE_LIBS = \ EXE_LIBS = \
-lfiniteVolume \ -lfiniteVolume \
-ldecompositionMethods \ -ldecompositionMethods \
-L$(FOAM_MPI_LIBBIN) -lptscotchDecomp \ -L$(FOAM_LIBBIN)/dummy -lptscotchDecomp \
-lmeshTools \ -lmeshTools \
-ldynamicMesh \ -ldynamicMesh \
-lautoMesh -lautoMesh

View File

@ -0,0 +1,47 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
\\/ 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 "SetPatchFields.H"
// * * * * * * * * * * * * * * * Global Functions * * * * * * * * * * * * * //
template<class GeoField>
void Foam::SetPatchFields
(
PtrList<GeoField>& fields,
const label patchI,
const typename GeoField::value_type& initVal
)
{
forAll(fields, i)
{
typename GeoField::PatchFieldType& pfld =
fields[i].boundaryField()[patchI];
pfld == initVal;
}
}
// ************************************************************************* //

View File

@ -0,0 +1,66 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 1991-2010 OpenCFD Ltd.
\\/ 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/>.
Global
Foam::SetPatchFields
Description
Helper routine to initialise a patch field to a constant value
SourceFiles
SetPatchFields.C
\*---------------------------------------------------------------------------*/
#ifndef SetPatchFields_H
#define SetPatchFields_H
#include "PtrList.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
//- Helper routine to read fields
template<class GeoField>
void SetPatchFields
(
PtrList<GeoField>& fields,
const label patchI,
const typename GeoField::value_type& initVal
);
} // End namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#ifdef NoRepository
# include "SetPatchFields.C"
#endif
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#endif
// ************************************************************************* //

View File

@ -43,6 +43,8 @@ Description
#include "volFields.H" #include "volFields.H"
#include "surfaceFields.H" #include "surfaceFields.H"
#include "ZoneIDs.H" #include "ZoneIDs.H"
#include "fvMeshMapper.H"
#include "SetPatchFields.H"
using namespace Foam; using namespace Foam;
@ -241,8 +243,6 @@ int main(int argc, char *argv[])
IOobjectList objects(mesh, runTime.timeName()); IOobjectList objects(mesh, runTime.timeName());
// Read vol fields. // Read vol fields.
if (args.optionFound("updateFields"))
{
Info<< "Reading geometric fields" << nl << endl; Info<< "Reading geometric fields" << nl << endl;
PtrList<volScalarField> vsFlds; PtrList<volScalarField> vsFlds;
ReadFields(mesh, objects, vsFlds); ReadFields(mesh, objects, vsFlds);
@ -275,11 +275,7 @@ int main(int argc, char *argv[])
PtrList<surfaceTensorField> stFlds; PtrList<surfaceTensorField> stFlds;
ReadFields(mesh, objects, stFlds); ReadFields(mesh, objects, stFlds);
}
else
{
Info<< "Not updating geometric fields" << nl << endl;
}
// Mesh change container // Mesh change container
polyTopoChange meshMod(mesh); polyTopoChange meshMod(mesh);
@ -484,6 +480,58 @@ int main(int argc, char *argv[])
// Update fields // Update fields
mesh.updateMesh(map); mesh.updateMesh(map);
// Correct boundary faces mapped-out-of-nothing.
{
fvMeshMapper mapper(mesh, map);
bool hasWarned = false;
forAll(newMasterPatches, i)
{
label patchI = newMasterPatches[i];
const fvPatchMapper& pm = mapper.boundaryMap()[patchI];
if (pm.sizeBeforeMapping() == 0)
{
if (!hasWarned)
{
hasWarned = true;
WarningIn(args.executable())
<< "Setting field on boundary faces to zero." << endl
<< "You might have to edit these fields." << endl;
}
SetPatchFields(vsFlds, patchI, pTraits<scalar>::zero);
SetPatchFields(vvFlds, patchI, pTraits<vector>::zero);
SetPatchFields(vstFlds, patchI, pTraits<sphericalTensor>::zero);
SetPatchFields(vsymtFlds, patchI, pTraits<symmTensor>::zero);
SetPatchFields(vtFlds, patchI, pTraits<tensor>::zero);
SetPatchFields(ssFlds, patchI, pTraits<scalar>::zero);
SetPatchFields(svFlds, patchI, pTraits<vector>::zero);
SetPatchFields(sstFlds, patchI, pTraits<sphericalTensor>::zero);
SetPatchFields(ssymtFlds, patchI, pTraits<symmTensor>::zero);
SetPatchFields(stFlds, patchI, pTraits<tensor>::zero);
}
}
forAll(newSlavePatches, i)
{
label patchI = newSlavePatches[i];
const fvPatchMapper& pm = mapper.boundaryMap()[patchI];
if (pm.sizeBeforeMapping() == 0)
{
SetPatchFields(vsFlds, patchI, pTraits<scalar>::zero);
SetPatchFields(vvFlds, patchI, pTraits<vector>::zero);
SetPatchFields(vstFlds, patchI, pTraits<sphericalTensor>::zero);
SetPatchFields(vsymtFlds, patchI, pTraits<symmTensor>::zero);
SetPatchFields(vtFlds, patchI, pTraits<tensor>::zero);
SetPatchFields(ssFlds, patchI, pTraits<scalar>::zero);
SetPatchFields(svFlds, patchI, pTraits<vector>::zero);
SetPatchFields(sstFlds, patchI, pTraits<sphericalTensor>::zero);
SetPatchFields(ssymtFlds, patchI, pTraits<symmTensor>::zero);
SetPatchFields(stFlds, patchI, pTraits<tensor>::zero);
}
}
}
// Move mesh (since morphing might not do this) // Move mesh (since morphing might not do this)
if (map().hasMotionPoints()) if (map().hasMotionPoints())
{ {

View File

@ -7,6 +7,6 @@ EXE_INC = \
EXE_LIBS = \ EXE_LIBS = \
-lfiniteVolume \ -lfiniteVolume \
-lgenericPatchFields \ -lgenericPatchFields \
-ldecompositionMethods -lmetisDecomp -lscotchDecomp \ -ldecompositionMethods -L$(FOAM_LIBBIN)/dummy -lmetisDecomp -lscotchDecomp \
-llagrangian \ -llagrangian \
-lmeshTools -lmeshTools

View File

@ -7,6 +7,6 @@ EXE_INC = \
EXE_LIBS = \ EXE_LIBS = \
-lfiniteVolume \ -lfiniteVolume \
-ldecompositionMethods \ -ldecompositionMethods \
-L$(FOAM_MPI_LIBBIN) -lptscotchDecomp \ -L$(FOAM_LIBBIN)/dummy -lptscotchDecomp \
-lmeshTools \ -lmeshTools \
-ldynamicMesh -ldynamicMesh

View File

@ -48,11 +48,13 @@ int main(int argc, char *argv[])
OFstream reactionsFile(args[3]); OFstream reactionsFile(args[3]);
reactionsFile reactionsFile
<< "species" << cr.species() << token::END_STATEMENT << nl << nl << "species" << cr.species() << token::END_STATEMENT << nl << nl;
<< "reactions" << cr.reactions() << token::END_STATEMENT << endl;
cr.reactions().write(reactionsFile);
OFstream thermoFile(args[4]); OFstream thermoFile(args[4]);
thermoFile<< cr.speciesThermo() << endl; cr.speciesThermo().write(thermoFile);
Info<< "End\n" << endl; Info<< "End\n" << endl;

View File

@ -72,6 +72,11 @@ class HashPtrTable
template<class INew> template<class INew>
void read(Istream&, const INew& inewt); void read(Istream&, const INew& inewt);
//- Read from dictionary using given dictionary constructor class
template<class INew>
void read(const dictionary& dict, const INew& inewt);
public: public:
@ -91,6 +96,10 @@ public:
//- Construct from Istream using default Istream constructor class //- Construct from Istream using default Istream constructor class
HashPtrTable(Istream&); HashPtrTable(Istream&);
//- Construct from dictionary using default dictionary constructor
// class
HashPtrTable(const dictionary& dict);
//- Construct as copy //- Construct as copy
HashPtrTable(const HashPtrTable<T, Key, Hash>&); HashPtrTable(const HashPtrTable<T, Key, Hash>&);
@ -112,6 +121,9 @@ public:
//- Clear all entries from table //- Clear all entries from table
void clear(); void clear();
//- Write
void write(Ostream& os) const;
// Member Operators // Member Operators

View File

@ -27,6 +27,7 @@ License
#include "Istream.H" #include "Istream.H"
#include "Ostream.H" #include "Ostream.H"
#include "INew.H" #include "INew.H"
#include "dictionary.H"
// * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * * // // * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * * //
@ -137,6 +138,39 @@ void Foam::HashPtrTable<T, Key, Hash>::read(Istream& is, const INew& inewt)
} }
template<class T, class Key, class Hash>
template<class INew>
void Foam::HashPtrTable<T, Key, Hash>::read
(
const dictionary& dict,
const INew& inewt
)
{
forAllConstIter(dictionary, dict, iter)
{
insert(iter().keyword(), inewt(dict.subDict(iter().keyword())).ptr());
}
}
template<class T, class Key, class Hash>
void Foam::HashPtrTable<T, Key, Hash>::write(Ostream& os) const
{
for
(
typename HashPtrTable<T, Key, Hash>::const_iterator
iter = this->begin();
iter != this->end();
++iter
)
{
const T* ptr = iter();
ptr->write(os);
}
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
template<class T, class Key, class Hash> template<class T, class Key, class Hash>
@ -154,6 +188,13 @@ Foam::HashPtrTable<T, Key, Hash>::HashPtrTable(Istream& is)
} }
template<class T, class Key, class Hash>
Foam::HashPtrTable<T, Key, Hash>::HashPtrTable(const dictionary& dict)
{
read(dict, INew<T>());
}
// * * * * * * * * * * * * * * * IOstream Operators * * * * * * * * * * * * // // * * * * * * * * * * * * * * * IOstream Operators * * * * * * * * * * * * //
template<class T, class Key, class Hash> template<class T, class Key, class Hash>

View File

@ -25,7 +25,7 @@ Class
Foam::INew Foam::INew
Description Description
A helper class when constructing from an Istream A helper class when constructing from an Istream or dictionary
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
@ -52,18 +52,33 @@ class INew
public: public:
//- Construct null
INew() INew()
{} {}
//- Construct from Istream
autoPtr<T> operator()(Istream& is) const autoPtr<T> operator()(Istream& is) const
{ {
return T::New(is); return T::New(is);
} }
//- Construct from word and Istream
autoPtr<T> operator()(const word&, Istream& is) const autoPtr<T> operator()(const word&, Istream& is) const
{ {
return T::New(is); return T::New(is);
} }
//- Construct from dictionary
autoPtr<T> operator()(const dictionary& dict) const
{
return T::New(dict);
}
//- Construct from word and dictionary
autoPtr<T> operator()(const word&, const dictionary& dict) const
{
return T::New(dict);
}
}; };

View File

@ -111,6 +111,23 @@ public:
{ {
return name_; return name_;
} }
//- Return the local dictionary name (final part of scoped name)
const word dictName() const
{
const word scopedName = name_.name();
string::size_type i = scopedName.rfind(':');
if (i == scopedName.npos)
{
return scopedName;
}
else
{
return scopedName.substr(i + 1, scopedName.npos);
}
}
}; };

View File

@ -106,13 +106,19 @@ public:
// Member functions // Member functions
//- Return the dictionary name //- Return the local dictionary name (final part of scoped name)
const word dictName() const
{
return dictionary::dictName();
}
//- Return the dictionary name (scoped, e.g. dictA::dictB::dictC)
const fileName& name() const const fileName& name() const
{ {
return dictionary::name(); return dictionary::name();
} }
//- Return the dictionary name //- Return the dictionary name (scoped, e.g. dictA::dictB::dictC)
fileName& name() fileName& name()
{ {
return dictionary::name(); return dictionary::name();

View File

@ -95,44 +95,58 @@ void Foam::cyclicPolyPatch::calcTransforms()
// Half0 // Half0
const cyclicPolyPatch& half0 = *this; const cyclicPolyPatch& half0 = *this;
const pointField& half0Ctrs = half0.faceCentres();
if (debug)
{
fileName casePath(boundaryMesh().mesh().time().path());
fileName nm0(casePath/name()+"_faces.obj");
Pout<< "cyclicPolyPatch::calcTransforms : Writing " << name()
<< " faces to OBJ file " << nm0 << endl;
writeOBJ(nm0, half0, half0.points());
}
vectorField half0Areas(half0.size()); vectorField half0Areas(half0.size());
forAll(half0, facei) forAll(half0, facei)
{ {
half0Areas[facei] = half0[facei].normal(half0.points()); half0Areas[facei] = half0[facei].normal(half0.points());
} }
// Half1 // Half1
const cyclicPolyPatch& half1 = neighbPatch(); const cyclicPolyPatch& half1 = neighbPatch();
vectorField half1Areas(half1.size());
forAll(half1, facei)
{
half1Areas[facei] = half1[facei].normal(half1.points());
}
const pointField& half1Ctrs = half1.faceCentres(); calcTransforms
(
half0,
half0.faceCentres(),
half0Areas,
half1.faceCentres(),
half1Areas
);
}
}
// Dump halves
if (debug) void Foam::cyclicPolyPatch::calcTransforms
(
const primitivePatch& half0,
const UList<point>& half0Ctrs,
const UList<point>& half0Areas,
const UList<point>& half1Ctrs,
const UList<point>& half1Areas
)
{
if (debug && owner())
{ {
fileName casePath(boundaryMesh().mesh().time().path()); fileName casePath(boundaryMesh().mesh().time().path());
{
fileName nm0(casePath/name()+"_faces.obj");
Pout<< "cyclicPolyPatch::calcTransforms : Writing " << name()
<< " faces to OBJ file " << nm0 << endl;
writeOBJ(nm0, half0, half0.points());
}
const cyclicPolyPatch& half1 = neighbPatch();
{
fileName nm1(casePath/half1.name()+"_faces.obj"); fileName nm1(casePath/half1.name()+"_faces.obj");
Pout<< "cyclicPolyPatch::calcTransforms : Writing " << half1.name() Pout<< "cyclicPolyPatch::calcTransforms : Writing " << half1.name()
<< " faces to OBJ file " << nm1 << endl; << " faces to OBJ file " << nm1 << endl;
writeOBJ(nm1, half1, half1.points()); writeOBJ(nm1, half1, half1.points());
}
{
OFstream str(casePath/name()+"_to_" + half1.name() + ".obj"); OFstream str(casePath/name()+"_to_" + half1.name() + ".obj");
label vertI = 0; label vertI = 0;
Pout<< "cyclicPolyPatch::calcTransforms :" Pout<< "cyclicPolyPatch::calcTransforms :"
@ -149,35 +163,10 @@ void Foam::cyclicPolyPatch::calcTransforms()
str << "l " << vertI-1 << ' ' << vertI << nl; str << "l " << vertI-1 << ' ' << vertI << nl;
} }
} }
vectorField half1Areas(half1.size());
forAll(half1, facei)
{
half1Areas[facei] = half1[facei].normal(half1.points());
} }
calcTransforms
(
half0,
half0Ctrs,
half0Areas,
half1Ctrs,
half1Areas
);
}
}
void Foam::cyclicPolyPatch::calcTransforms
(
const primitivePatch& half0,
const UList<point>& half0Ctrs,
const UList<point>& half0Areas,
const UList<point>& half1Ctrs,
const UList<point>& half1Areas
)
{
if (half0Ctrs.size() != half1Ctrs.size()) if (half0Ctrs.size() != half1Ctrs.size())
{ {
FatalErrorIn FatalErrorIn

View File

@ -111,6 +111,15 @@ Foam::Polynomial<PolySize>::Polynomial(const word& name, Istream& is)
} }
template<int PolySize>
Foam::Polynomial<PolySize>::Polynomial(Istream& is)
:
VectorSpace<Polynomial<PolySize>, scalar, PolySize>(is),
logActive_(false),
logCoeff_(0.0)
{}
template<int PolySize> template<int PolySize>
Foam::Polynomial<PolySize>::Polynomial Foam::Polynomial<PolySize>::Polynomial
( (

View File

@ -110,6 +110,9 @@ public:
//- Construct from a list of coefficients //- Construct from a list of coefficients
explicit Polynomial(const UList<scalar>& coeffs); explicit Polynomial(const UList<scalar>& coeffs);
//- Construct from Istream
Polynomial(Istream& is);
//- Construct from name and Istream //- Construct from name and Istream
Polynomial(const word& name, Istream& is); Polynomial(const word& name, Istream& is);

View File

@ -34,14 +34,13 @@ scalar meanMeshCoNum = 0.0;
if (mesh.nInternalFaces()) if (mesh.nInternalFaces())
{ {
surfaceScalarField SfUfbyDelta = scalarField sumPhi =
mesh.surfaceInterpolation::deltaCoeffs()*mag(mesh.phi()); fvc::surfaceSum(mag(mesh.phi()))().internalField();
meshCoNum = max(SfUfbyDelta/mesh.magSf()) meshCoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
.value()*runTime.deltaTValue();
meanMeshCoNum = (sum(SfUfbyDelta)/sum(mesh.magSf())) meanMeshCoNum =
.value()*runTime.deltaTValue(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
} }
Info<< "Mesh Courant Number mean: " << meanMeshCoNum Info<< "Mesh Courant Number mean: " << meanMeshCoNum

View File

@ -38,10 +38,10 @@ if (mesh.nInternalFaces())
fvc::surfaceSum(mag(phi))().internalField() fvc::surfaceSum(mag(phi))().internalField()
/rho.internalField(); /rho.internalField();
CoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaT().value(); CoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
meanCoNum = meanCoNum =
0.5*(gSum(sumPhi)/sum(mesh.V().field()))*runTime.deltaT().value(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
} }
Info<< "Courant Number mean: " << meanCoNum Info<< "Courant Number mean: " << meanCoNum

View File

@ -37,10 +37,10 @@ if (mesh.nInternalFaces())
scalarField sumPhi = scalarField sumPhi =
fvc::surfaceSum(mag(phi))().internalField(); fvc::surfaceSum(mag(phi))().internalField();
CoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaT().value(); CoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
meanCoNum = meanCoNum =
0.5*(gSum(sumPhi)/sum(mesh.V().field()))*runTime.deltaT().value(); 0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
} }
Info<< "Courant Number mean: " << meanCoNum Info<< "Courant Number mean: " << meanCoNum

View File

@ -260,7 +260,7 @@ void directMappedFixedValueFvPatchField<Type>::updateCoeffs()
allValues allValues
); );
newValues = this->patch().patchSlice(allValues); newValues.transfer(allValues);
break; break;
} }

View File

@ -198,7 +198,7 @@ void directMappedVelocityFluxFixedValueFvPatchField::updateCoeffs()
distMap.constructMap(), distMap.constructMap(),
allUValues allUValues
); );
newUValues = patch().patchSlice(allUValues); newUValues.transfer(allUValues);
mapDistribute::distribute mapDistribute::distribute
( (
@ -209,7 +209,7 @@ void directMappedVelocityFluxFixedValueFvPatchField::updateCoeffs()
distMap.constructMap(), distMap.constructMap(),
allPhiValues allPhiValues
); );
newPhiValues = patch().patchSlice(allPhiValues); newPhiValues.transfer(allPhiValues);
break; break;
} }

View File

@ -23,8 +23,6 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "error.H"
#include "basicMixture.H" #include "basicMixture.H"
#include "fvMesh.H" #include "fvMesh.H"
@ -39,11 +37,7 @@ defineTypeNameAndDebug(basicMixture, 0);
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
basicMixture::basicMixture basicMixture::basicMixture(const dictionary&, const fvMesh&)
(
const dictionary&,
const fvMesh&
)
{} {}

View File

@ -23,8 +23,6 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "error.H"
#include "pureMixture.H" #include "pureMixture.H"
#include "fvMesh.H" #include "fvMesh.H"
@ -43,7 +41,7 @@ pureMixture<ThermoType>::pureMixture
) )
: :
basicMixture(thermoDict, mesh), basicMixture(thermoDict, mesh),
mixture_(thermoDict.lookup("mixture")) mixture_(thermoDict.subDict("mixture"))
{} {}
@ -59,7 +57,7 @@ pureMixture<ThermoType>::~pureMixture()
template<class ThermoType> template<class ThermoType>
void pureMixture<ThermoType>::read(const dictionary& thermoDict) void pureMixture<ThermoType>::read(const dictionary& thermoDict)
{ {
mixture_ = ThermoType(thermoDict.lookup("mixture")); mixture_ = ThermoType(thermoDict.subDict("mixture"));
} }

View File

@ -114,7 +114,7 @@ Foam::ePsiThermo<MixtureType>::ePsiThermo(const fvMesh& mesh)
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, 0, 0), dimEnergy/dimMass,
this->eBoundaryTypes() this->eBoundaryTypes()
) )
{ {
@ -245,7 +245,7 @@ Foam::tmp<Foam::volScalarField> Foam::ePsiThermo<MixtureType>::Cp() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, -1, 0) dimEnergy/dimMass/dimTemperature
) )
); );
@ -308,7 +308,7 @@ Foam::tmp<Foam::volScalarField> Foam::ePsiThermo<MixtureType>::Cv() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, -1, 0) dimEnergy/dimMass/dimTemperature
) )
); );

View File

@ -112,7 +112,7 @@ Foam::hPsiThermo<MixtureType>::hPsiThermo(const fvMesh& mesh)
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, 0, 0), dimEnergy/dimMass,
this->hBoundaryTypes() this->hBoundaryTypes()
) )
{ {
@ -243,7 +243,7 @@ Foam::tmp<Foam::volScalarField> Foam::hPsiThermo<MixtureType>::Cp() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, -1, 0) dimEnergy/dimMass/dimTemperature
) )
); );
@ -306,7 +306,7 @@ Foam::tmp<Foam::volScalarField> Foam::hPsiThermo<MixtureType>::Cv() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, -1, 0) dimEnergy/dimMass/dimTemperature
) )
); );

View File

@ -243,7 +243,7 @@ Foam::tmp<Foam::volScalarField> Foam::hsPsiThermo<MixtureType>::Cp() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, -1, 0) dimEnergy/dimMass/dimTemperature
) )
); );

View File

@ -117,7 +117,7 @@ Foam::hRhoThermo<MixtureType>::hRhoThermo(const fvMesh& mesh)
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, 0, 0), dimEnergy/dimMass,
this->hBoundaryTypes() this->hBoundaryTypes()
) )
{ {
@ -242,7 +242,7 @@ Foam::tmp<Foam::volScalarField> Foam::hRhoThermo<MixtureType>::Cp() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, -1, 0) dimEnergy/dimMass/dimTemperature
) )
); );
@ -305,7 +305,7 @@ Foam::tmp<Foam::volScalarField> Foam::hRhoThermo<MixtureType>::Cv() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionSet(0, 2, -2, -1, 0) dimEnergy/dimMass/dimTemperature
) )
); );

View File

@ -69,8 +69,7 @@ public:
TypeName("basicSolidThermo"); TypeName("basicSolidThermo");
// Declare run-time constructor selection tables //- Declare run-time constructor selection tables
declareRunTimeSelectionTable declareRunTimeSelectionTable
( (
autoPtr, autoPtr,
@ -91,8 +90,7 @@ public:
static autoPtr<basicSolidThermo> New(const fvMesh&); static autoPtr<basicSolidThermo> New(const fvMesh&);
// Destructor //- Destructor
virtual ~basicSolidThermo(); virtual ~basicSolidThermo();
@ -149,6 +147,7 @@ public:
//- Emissivity [] //- Emissivity []
virtual tmp<scalarField> emissivity(const label) const = 0; virtual tmp<scalarField> emissivity(const label) const = 0;
// // Point wise properties // // Point wise properties
// //
// //- Density [kg/m3] // //- Density [kg/m3]
@ -166,6 +165,7 @@ public:
// //- Emissivity [] // //- Emissivity []
// virtual scalar emissivity(const scalar T) const = 0; // virtual scalar emissivity(const scalar T) const = 0;
// I-O // I-O
//- Write the basicSolidThermo properties //- Write the basicSolidThermo properties

View File

@ -228,8 +228,6 @@ Foam::directionalSolidThermo::directionalSolidThermo(const fvMesh& mesh)
} }
} }
correct(); correct();
} }

View File

@ -57,11 +57,7 @@ Foam::liquidMixture::liquidMixture
forAll(components_, i) forAll(components_, i)
{ {
properties_.set properties_.set(i, liquid::New(props.subDict(components_[i])));
(
i,
liquid::New(props.lookup(components_[i]))
);
} }
} }
@ -79,12 +75,8 @@ Foam::autoPtr<Foam::liquidMixture> Foam::liquidMixture::New
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
Foam::scalar Foam::liquidMixture::Tc Foam::scalar Foam::liquidMixture::Tc(const scalarField& x) const
(
const scalarField& x
) const
{ {
scalar vTc = 0.0; scalar vTc = 0.0;
scalar vc = 0.0; scalar vc = 0.0;
@ -99,10 +91,7 @@ Foam::scalar Foam::liquidMixture::Tc
} }
Foam::scalar Foam::liquidMixture::Tpc Foam::scalar Foam::liquidMixture::Tpc(const scalarField& x) const
(
const scalarField& x
) const
{ {
scalar Tpc = 0.0; scalar Tpc = 0.0;
forAll(properties_, i) forAll(properties_, i)
@ -114,10 +103,7 @@ Foam::scalar Foam::liquidMixture::Tpc
} }
Foam::scalar Foam::liquidMixture::Ppc Foam::scalar Foam::liquidMixture::Ppc(const scalarField& x) const
(
const scalarField& x
) const
{ {
scalar Vc = 0.0; scalar Vc = 0.0;
scalar Zc = 0.0; scalar Zc = 0.0;
@ -131,10 +117,7 @@ Foam::scalar Foam::liquidMixture::Ppc
} }
Foam::scalar Foam::liquidMixture::omega Foam::scalar Foam::liquidMixture::omega(const scalarField& x) const
(
const scalarField& x
) const
{ {
scalar omega = 0.0; scalar omega = 0.0;
forAll(properties_, i) forAll(properties_, i)
@ -167,10 +150,7 @@ Foam::scalarField Foam::liquidMixture::Xs
} }
Foam::scalar Foam::liquidMixture::W Foam::scalar Foam::liquidMixture::W(const scalarField& x) const
(
const scalarField& x
) const
{ {
scalar W = 0.0; scalar W = 0.0;
forAll(properties_, i) forAll(properties_, i)
@ -182,10 +162,7 @@ Foam::scalar Foam::liquidMixture::W
} }
Foam::scalarField Foam::liquidMixture::Y Foam::scalarField Foam::liquidMixture::Y(const scalarField& X) const
(
const scalarField& X
) const
{ {
scalarField Y(X/W(X)); scalarField Y(X/W(X));
@ -198,10 +175,7 @@ Foam::scalarField Foam::liquidMixture::Y
} }
Foam::scalarField Foam::liquidMixture::X Foam::scalarField Foam::liquidMixture::X(const scalarField& Y) const
(
const scalarField& Y
) const
{ {
scalarField X(Y.size()); scalarField X(Y.size());
scalar Winv = 0.0; scalar Winv = 0.0;

View File

@ -33,9 +33,9 @@ namespace Foam
defineTypeNameAndDebug(Ar, 0); defineTypeNameAndDebug(Ar, 0);
addToRunTimeSelectionTable(liquid, Ar,); addToRunTimeSelectionTable(liquid, Ar,);
addToRunTimeSelectionTable(liquid, Ar, Istream); addToRunTimeSelectionTable(liquid, Ar, Istream);
addToRunTimeSelectionTable(liquid, Ar, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::Ar::Ar() Foam::Ar::Ar()
@ -139,4 +139,23 @@ Foam::Ar::Ar(Istream& is)
{} {}
Foam::Ar::Ar(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
Ar(Istream& is); Ar(Istream& is);
//- Construct from dictionary
Ar(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C10H22, 0); defineTypeNameAndDebug(C10H22, 0);
addToRunTimeSelectionTable(liquid, C10H22,); addToRunTimeSelectionTable(liquid, C10H22,);
addToRunTimeSelectionTable(liquid, C10H22, Istream); addToRunTimeSelectionTable(liquid, C10H22, Istream);
addToRunTimeSelectionTable(liquid, C10H22, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C10H22::C10H22(Istream& is)
{} {}
Foam::C10H22::C10H22(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C10H22(Istream& is); C10H22(Istream& is);
//- Construct from dictionary
C10H22(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C12H26, 0); defineTypeNameAndDebug(C12H26, 0);
addToRunTimeSelectionTable(liquid, C12H26,); addToRunTimeSelectionTable(liquid, C12H26,);
addToRunTimeSelectionTable(liquid, C12H26, Istream); addToRunTimeSelectionTable(liquid, C12H26, Istream);
addToRunTimeSelectionTable(liquid, C12H26, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -138,4 +139,23 @@ Foam::C12H26::C12H26(Istream& is)
{} {}
Foam::C12H26::C12H26(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C12H26(Istream& is); C12H26(Istream& is);
//- Construct from dictionary
C12H26(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C13H28, 0); defineTypeNameAndDebug(C13H28, 0);
addToRunTimeSelectionTable(liquid, C13H28,); addToRunTimeSelectionTable(liquid, C13H28,);
addToRunTimeSelectionTable(liquid, C13H28, Istream); addToRunTimeSelectionTable(liquid, C13H28, Istream);
addToRunTimeSelectionTable(liquid, C13H28, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C13H28::C13H28(Istream& is)
{} {}
Foam::C13H28::C13H28(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C13H28(Istream& is); C13H28(Istream& is);
//- Construct from dictionary
C13H28(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C14H30, 0); defineTypeNameAndDebug(C14H30, 0);
addToRunTimeSelectionTable(liquid, C14H30,); addToRunTimeSelectionTable(liquid, C14H30,);
addToRunTimeSelectionTable(liquid, C14H30, Istream); addToRunTimeSelectionTable(liquid, C14H30, Istream);
addToRunTimeSelectionTable(liquid, C14H30, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C14H30::C14H30(Istream& is)
{} {}
Foam::C14H30::C14H30(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C14H30(Istream& is); C14H30(Istream& is);
//- Construct from dictionary
C14H30(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C16H34, 0); defineTypeNameAndDebug(C16H34, 0);
addToRunTimeSelectionTable(liquid, C16H34,); addToRunTimeSelectionTable(liquid, C16H34,);
addToRunTimeSelectionTable(liquid, C16H34, Istream); addToRunTimeSelectionTable(liquid, C16H34, Istream);
addToRunTimeSelectionTable(liquid, C16H34, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C16H34::C16H34(Istream& is)
{} {}
Foam::C16H34::C16H34(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C16H34(Istream& is); C16H34(Istream& is);
//- Construct from dictionary
C16H34(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C2H5OH, 0); defineTypeNameAndDebug(C2H5OH, 0);
addToRunTimeSelectionTable(liquid, C2H5OH,); addToRunTimeSelectionTable(liquid, C2H5OH,);
addToRunTimeSelectionTable(liquid, C2H5OH, Istream); addToRunTimeSelectionTable(liquid, C2H5OH, Istream);
addToRunTimeSelectionTable(liquid, C2H5OH, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C2H5OH::C2H5OH(Istream& is)
{} {}
Foam::C2H5OH::C2H5OH(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C2H5OH(Istream& is); C2H5OH(Istream& is);
//- Construct from dictionary
C2H5OH(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C2H6, 0); defineTypeNameAndDebug(C2H6, 0);
addToRunTimeSelectionTable(liquid, C2H6,); addToRunTimeSelectionTable(liquid, C2H6,);
addToRunTimeSelectionTable(liquid, C2H6, Istream); addToRunTimeSelectionTable(liquid, C2H6, Istream);
addToRunTimeSelectionTable(liquid, C2H6, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -137,4 +138,23 @@ Foam::C2H6::C2H6(Istream& is)
{} {}
Foam::C2H6::C2H6(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C2H6(Istream& is); C2H6(Istream& is);
//- Construct from dictionary
C2H6(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C2H6O, 0); defineTypeNameAndDebug(C2H6O, 0);
addToRunTimeSelectionTable(liquid, C2H6O,); addToRunTimeSelectionTable(liquid, C2H6O,);
addToRunTimeSelectionTable(liquid, C2H6O, Istream); addToRunTimeSelectionTable(liquid, C2H6O, Istream);
addToRunTimeSelectionTable(liquid, C2H6O, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C2H6O::C2H6O(Istream& is)
{} {}
Foam::C2H6O::C2H6O(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C2H6O(Istream& is); C2H6O(Istream& is);
//- Construct from dictionary
C2H6O(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C3H6O, 0); defineTypeNameAndDebug(C3H6O, 0);
addToRunTimeSelectionTable(liquid, C3H6O,); addToRunTimeSelectionTable(liquid, C3H6O,);
addToRunTimeSelectionTable(liquid, C3H6O, Istream); addToRunTimeSelectionTable(liquid, C3H6O, Istream);
addToRunTimeSelectionTable(liquid, C3H6O, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C3H6O::C3H6O(Istream& is)
{} {}
Foam::C3H6O::C3H6O(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C3H6O(Istream& is); C3H6O(Istream& is);
//- Construct from dictionary
C3H6O(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,7 +33,9 @@ namespace Foam
defineTypeNameAndDebug(C3H8, 0); defineTypeNameAndDebug(C3H8, 0);
addToRunTimeSelectionTable(liquid, C3H8,); addToRunTimeSelectionTable(liquid, C3H8,);
addToRunTimeSelectionTable(liquid, C3H8, Istream); addToRunTimeSelectionTable(liquid, C3H8, Istream);
addToRunTimeSelectionTable(liquid, C3H8, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::C3H8::C3H8() Foam::C3H8::C3H8()
@ -135,4 +137,23 @@ Foam::C3H8::C3H8(Istream& is)
{} {}
Foam::C3H8::C3H8(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C3H8(Istream& is); C3H8(Istream& is);
//- Construct from dictionary
C3H8(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C4H10O, 0); defineTypeNameAndDebug(C4H10O, 0);
addToRunTimeSelectionTable(liquid, C4H10O,); addToRunTimeSelectionTable(liquid, C4H10O,);
addToRunTimeSelectionTable(liquid, C4H10O, Istream); addToRunTimeSelectionTable(liquid, C4H10O, Istream);
addToRunTimeSelectionTable(liquid, C4H10O, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C4H10O::C4H10O(Istream& is)
{} {}
Foam::C4H10O::C4H10O(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C4H10O(Istream& is); C4H10O(Istream& is);
//- Construct from dictionary
C4H10O(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C6H14, 0); defineTypeNameAndDebug(C6H14, 0);
addToRunTimeSelectionTable(liquid, C6H14,); addToRunTimeSelectionTable(liquid, C6H14,);
addToRunTimeSelectionTable(liquid, C6H14, Istream); addToRunTimeSelectionTable(liquid, C6H14, Istream);
addToRunTimeSelectionTable(liquid, C6H14, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C6H14::C6H14(Istream& is)
{} {}
Foam::C6H14::C6H14(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C6H14(Istream& is); C6H14(Istream& is);
//- Construct from dictionary
C6H14(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C6H6, 0); defineTypeNameAndDebug(C6H6, 0);
addToRunTimeSelectionTable(liquid, C6H6,); addToRunTimeSelectionTable(liquid, C6H6,);
addToRunTimeSelectionTable(liquid, C6H6, Istream); addToRunTimeSelectionTable(liquid, C6H6, Istream);
addToRunTimeSelectionTable(liquid, C6H6, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C6H6::C6H6(Istream& is)
{} {}
Foam::C6H6::C6H6(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C6H6(Istream& is); C6H6(Istream& is);
//- Construct from dictionary
C6H6(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C7H16, 0); defineTypeNameAndDebug(C7H16, 0);
addToRunTimeSelectionTable(liquid, C7H16,); addToRunTimeSelectionTable(liquid, C7H16,);
addToRunTimeSelectionTable(liquid, C7H16, Istream); addToRunTimeSelectionTable(liquid, C7H16, Istream);
addToRunTimeSelectionTable(liquid, C7H16, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -145,4 +146,23 @@ Foam::C7H16::C7H16(Istream& is)
{} {}
Foam::C7H16::C7H16(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C7H16(Istream& is); C7H16(Istream& is);
//- Construct from dictionary
C7H16(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C7H8, 0); defineTypeNameAndDebug(C7H8, 0);
addToRunTimeSelectionTable(liquid, C7H8,); addToRunTimeSelectionTable(liquid, C7H8,);
addToRunTimeSelectionTable(liquid, C7H8, Istream); addToRunTimeSelectionTable(liquid, C7H8, Istream);
addToRunTimeSelectionTable(liquid, C7H8, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C7H8::C7H8(Istream& is)
{} {}
Foam::C7H8::C7H8(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C7H8(Istream& is); C7H8(Istream& is);
//- Construct from dictionary
C7H8(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C8H10, 0); defineTypeNameAndDebug(C8H10, 0);
addToRunTimeSelectionTable(liquid, C8H10,); addToRunTimeSelectionTable(liquid, C8H10,);
addToRunTimeSelectionTable(liquid, C8H10, Istream); addToRunTimeSelectionTable(liquid, C8H10, Istream);
addToRunTimeSelectionTable(liquid, C8H10, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C8H10::C8H10(Istream& is)
{} {}
Foam::C8H10::C8H10(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -109,6 +109,9 @@ public:
//- Construct from Istream //- Construct from Istream
C8H10(Istream& is); C8H10(Istream& is);
//- Construct from dictionary
C8H10(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C8H18, 0); defineTypeNameAndDebug(C8H18, 0);
addToRunTimeSelectionTable(liquid, C8H18,); addToRunTimeSelectionTable(liquid, C8H18,);
addToRunTimeSelectionTable(liquid, C8H18, Istream); addToRunTimeSelectionTable(liquid, C8H18, Istream);
addToRunTimeSelectionTable(liquid, C8H18, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C8H18::C8H18(Istream& is)
{} {}
Foam::C8H18::C8H18(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C8H18(Istream& is); C8H18(Istream& is);
//- Construct from dictionary
C8H18(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(C9H20, 0); defineTypeNameAndDebug(C9H20, 0);
addToRunTimeSelectionTable(liquid, C9H20,); addToRunTimeSelectionTable(liquid, C9H20,);
addToRunTimeSelectionTable(liquid, C9H20, Istream); addToRunTimeSelectionTable(liquid, C9H20, Istream);
addToRunTimeSelectionTable(liquid, C9H20, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::C9H20::C9H20(Istream& is)
{} {}
Foam::C9H20::C9H20(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
C9H20(Istream& is); C9H20(Istream& is);
//- Construct from dictionary
C9H20(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(CH3OH, 0); defineTypeNameAndDebug(CH3OH, 0);
addToRunTimeSelectionTable(liquid, CH3OH,); addToRunTimeSelectionTable(liquid, CH3OH,);
addToRunTimeSelectionTable(liquid, CH3OH, Istream); addToRunTimeSelectionTable(liquid, CH3OH, Istream);
addToRunTimeSelectionTable(liquid, CH3OH, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::CH3OH::CH3OH(Istream& is)
{} {}
Foam::CH3OH::CH3OH(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
CH3OH(Istream& is); CH3OH(Istream& is);
//- Construct from dictionary
CH3OH(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -34,6 +34,7 @@ namespace Foam
defineTypeNameAndDebug(CH4N2O, 0); defineTypeNameAndDebug(CH4N2O, 0);
addToRunTimeSelectionTable(liquid, CH4N2O,); addToRunTimeSelectionTable(liquid, CH4N2O,);
addToRunTimeSelectionTable(liquid, CH4N2O, Istream); addToRunTimeSelectionTable(liquid, CH4N2O, Istream);
addToRunTimeSelectionTable(liquid, CH4N2O, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -131,4 +132,23 @@ Foam::CH4N2O::CH4N2O(Istream& is)
{} {}
Foam::CH4N2O::CH4N2O(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
CH4N2O(Istream& is); CH4N2O(Istream& is);
//- Construct from dictionary
CH4N2O(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(H2O, 0); defineTypeNameAndDebug(H2O, 0);
addToRunTimeSelectionTable(liquid, H2O,); addToRunTimeSelectionTable(liquid, H2O,);
addToRunTimeSelectionTable(liquid, H2O, Istream); addToRunTimeSelectionTable(liquid, H2O, Istream);
addToRunTimeSelectionTable(liquid, H2O, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -153,4 +154,23 @@ Foam::H2O::H2O(Istream& is)
{} {}
Foam::H2O::H2O(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -109,6 +109,9 @@ public:
//- Construct from Istream //- Construct from Istream
H2O(Istream& is); H2O(Istream& is);
//- Construct from dictionary
H2O(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(IC8H18, 0); defineTypeNameAndDebug(IC8H18, 0);
addToRunTimeSelectionTable(liquid, IC8H18,); addToRunTimeSelectionTable(liquid, IC8H18,);
addToRunTimeSelectionTable(liquid, IC8H18, Istream); addToRunTimeSelectionTable(liquid, IC8H18, Istream);
addToRunTimeSelectionTable(liquid, IC8H18, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::IC8H18::IC8H18(Istream& is)
{} {}
Foam::IC8H18::IC8H18(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
IC8H18(Istream& is); IC8H18(Istream& is);
//- Construct from dictionary
IC8H18(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(IDEA, 0); defineTypeNameAndDebug(IDEA, 0);
addToRunTimeSelectionTable(liquid, IDEA,); addToRunTimeSelectionTable(liquid, IDEA,);
addToRunTimeSelectionTable(liquid, IDEA, Istream); addToRunTimeSelectionTable(liquid, IDEA, Istream);
addToRunTimeSelectionTable(liquid, IDEA, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -166,4 +167,23 @@ Foam::IDEA::IDEA(Istream& is)
{} {}
Foam::IDEA::IDEA(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -132,6 +132,9 @@ public:
//- Construct from Istream //- Construct from Istream
IDEA(Istream& is); IDEA(Istream& is);
//- Construct from dictionary
IDEA(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(MB, 0); defineTypeNameAndDebug(MB, 0);
addToRunTimeSelectionTable(liquid, MB,); addToRunTimeSelectionTable(liquid, MB,);
addToRunTimeSelectionTable(liquid, MB, Istream); addToRunTimeSelectionTable(liquid, MB, Istream);
addToRunTimeSelectionTable(liquid, MB, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -130,4 +131,23 @@ Foam::MB::MB(Istream& is)
{} {}
Foam::MB::MB(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
MB(Istream& is); MB(Istream& is);
//- Construct from dictionary
MB(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(N2, 0); defineTypeNameAndDebug(N2, 0);
addToRunTimeSelectionTable(liquid, N2,); addToRunTimeSelectionTable(liquid, N2,);
addToRunTimeSelectionTable(liquid, N2, Istream); addToRunTimeSelectionTable(liquid, N2, Istream);
addToRunTimeSelectionTable(liquid, N2, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::N2::N2(Istream& is)
{} {}
Foam::N2::N2(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
N2(Istream& is); N2(Istream& is);
//- Construct from dictionary
N2(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(aC10H7CH3, 0); defineTypeNameAndDebug(aC10H7CH3, 0);
addToRunTimeSelectionTable(liquid, aC10H7CH3,); addToRunTimeSelectionTable(liquid, aC10H7CH3,);
addToRunTimeSelectionTable(liquid, aC10H7CH3, Istream); addToRunTimeSelectionTable(liquid, aC10H7CH3, Istream);
addToRunTimeSelectionTable(liquid, aC10H7CH3, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -138,4 +139,23 @@ Foam::aC10H7CH3::aC10H7CH3(Istream& is)
{} {}
Foam::aC10H7CH3::aC10H7CH3(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
aC10H7CH3(Istream& is); aC10H7CH3(Istream& is);
//- Construct from dictionary
aC10H7CH3(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(bC10H7CH3, 0); defineTypeNameAndDebug(bC10H7CH3, 0);
addToRunTimeSelectionTable(liquid, bC10H7CH3,); addToRunTimeSelectionTable(liquid, bC10H7CH3,);
addToRunTimeSelectionTable(liquid, bC10H7CH3, Istream); addToRunTimeSelectionTable(liquid, bC10H7CH3, Istream);
addToRunTimeSelectionTable(liquid, bC10H7CH3, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -138,4 +139,23 @@ Foam::bC10H7CH3::bC10H7CH3(Istream& is)
{} {}
Foam::bC10H7CH3::bC10H7CH3(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -110,6 +110,9 @@ public:
//- Construct from Istream //- Construct from Istream
bC10H7CH3(Istream& is); bC10H7CH3(Istream& is);
//- Construct from dictionary
bC10H7CH3(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -33,6 +33,7 @@ namespace Foam
defineTypeNameAndDebug(iC3H8O, 0); defineTypeNameAndDebug(iC3H8O, 0);
addToRunTimeSelectionTable(liquid, iC3H8O,); addToRunTimeSelectionTable(liquid, iC3H8O,);
addToRunTimeSelectionTable(liquid, iC3H8O, Istream); addToRunTimeSelectionTable(liquid, iC3H8O, Istream);
addToRunTimeSelectionTable(liquid, iC3H8O, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -146,4 +147,23 @@ Foam::iC3H8O::iC3H8O(Istream& is)
{} {}
Foam::iC3H8O::iC3H8O(const dictionary& dict)
:
liquid(dict),
rho_(dict.subDict("rho")),
pv_(dict.subDict("pv")),
hl_(dict.subDict("hl")),
cp_(dict.subDict("cp")),
h_(dict.subDict("h")),
cpg_(dict.subDict("cpg")),
B_(dict.subDict("B")),
mu_(dict.subDict("mu")),
mug_(dict.subDict("mug")),
K_(dict.subDict("K")),
Kg_(dict.subDict("Kg")),
sigma_(dict.subDict("sigma")),
D_(dict.subDict("D"))
{}
// ************************************************************************* // // ************************************************************************* //

View File

@ -108,6 +108,9 @@ public:
//- Construct from Istream //- Construct from Istream
iC3H8O(Istream& is); iC3H8O(Istream& is);
//- Construct from dictionary
iC3H8O(const dictionary& dict);
// Member Functions // Member Functions

View File

@ -23,10 +23,9 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "error.H"
#include "liquid.H" #include "liquid.H"
#include "HashTable.H" #include "HashTable.H"
#include "Switch.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -35,10 +34,66 @@ namespace Foam
defineTypeNameAndDebug(liquid, 0); defineTypeNameAndDebug(liquid, 0);
defineRunTimeSelectionTable(liquid,); defineRunTimeSelectionTable(liquid,);
defineRunTimeSelectionTable(liquid, Istream); defineRunTimeSelectionTable(liquid, Istream);
defineRunTimeSelectionTable(liquid, dictionary);
} }
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::liquid::liquid
(
scalar W,
scalar Tc,
scalar Pc,
scalar Vc,
scalar Zc,
scalar Tt,
scalar Pt,
scalar Tb,
scalar dipm,
scalar omega,
scalar delta
)
:
W_(W),
Tc_(Tc),
Pc_(Pc),
Vc_(Vc),
Zc_(Zc),
Tt_(Tt),
Pt_(Pt),
Tb_(Tb),
dipm_(dipm),
omega_(omega),
delta_(delta)
{}
Foam::liquid::liquid(Istream& is)
:
W_(readScalar(is)),
Tc_(readScalar(is)),
Pc_(readScalar(is)),
Vc_(readScalar(is)),
dipm_(readScalar(is)),
omega_(readScalar(is)),
delta_(readScalar(is))
{}
Foam::liquid::liquid(const dictionary& dict)
:
W_(readScalar(dict.lookup("W"))),
Tc_(readScalar(dict.lookup("Tc"))),
Pc_(readScalar(dict.lookup("Pc"))),
Vc_(readScalar(dict.lookup("Vc"))),
dipm_(readScalar(dict.lookup("dipm"))),
omega_(readScalar(dict.lookup("omega"))),
delta_(readScalar(dict.lookup("delta")))
{}
// * * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * //
Foam::autoPtr<Foam::liquid> Foam::liquid::New(Istream& is) Foam::autoPtr<Foam::liquid> Foam::liquid::New(Istream& is)
{ {
if (debug) if (debug)
@ -96,4 +151,56 @@ Foam::autoPtr<Foam::liquid> Foam::liquid::New(Istream& is)
} }
Foam::autoPtr<Foam::liquid> Foam::liquid::New(const dictionary& dict)
{
if (debug)
{
Info<< "liquid::New(const dictionary&) : " << "constructing liquid"
<< endl;
}
const word& liquidTypeName = dict.dictName();
const Switch defaultCoeffs(dict.lookup("defaultCoeffs"));
if (defaultCoeffs)
{
ConstructorTable::iterator cstrIter =
ConstructorTablePtr_->find(liquidTypeName);
if (cstrIter == ConstructorTablePtr_->end())
{
FatalErrorIn("liquid::New(const dictionary&, const word&)")
<< "Unknown liquid type "
<< liquidTypeName << nl << nl
<< "Valid liquid types are:" << nl
<< ConstructorTablePtr_->sortedToc()
<< abort(FatalError);
}
return autoPtr<liquid>(cstrIter()());
}
else
{
dictionaryConstructorTable::iterator cstrIter =
dictionaryConstructorTablePtr_->find(liquidTypeName);
if (cstrIter == dictionaryConstructorTablePtr_->end())
{
FatalErrorIn("liquid::New(const dictionary&, const word&)")
<< "Unknown liquid type "
<< liquidTypeName << nl << nl
<< "Valid liquid types are:" << nl
<< dictionaryConstructorTablePtr_->sortedToc()
<< abort(FatalError);
}
return autoPtr<liquid>
(
cstrIter()(dict.subDict(liquidTypeName + "Coeffs"))
);
}
}
// ************************************************************************* // // ************************************************************************* //

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