mirror of
https://develop.openfoam.com/Development/openfoam.git
synced 2025-11-28 03:28:01 +00:00
Merge commit 'OpenCFD/master' into olesenm
This commit is contained in:
@ -238,8 +238,7 @@ void Foam::kineticTheoryModel::solve()
|
||||
volScalarField ThetaSqrt = sqrt(Theta_);
|
||||
|
||||
// 'thermal' conductivity (Table 3.3, p. 49)
|
||||
volScalarField kappa_ =
|
||||
conductivityModel_->kappa(alpha, Theta_, gs0_, rhoa_, da_, e_);
|
||||
kappa_ = conductivityModel_->kappa(alpha, Theta_, gs0_, rhoa_, da_, e_);
|
||||
|
||||
// particle viscosity (Table 3.2, p.47)
|
||||
mua_ = viscosityModel_->mua(alpha, Theta_, gs0_, rhoa_, da_, e_);
|
||||
@ -256,8 +255,7 @@ void Foam::kineticTheoryModel::solve()
|
||||
/(alpha*rhoa_*sqrtPi*(ThetaSqrt + TsmallSqrt));
|
||||
|
||||
// bulk viscosity p. 45 (Lun et al. 1984).
|
||||
volScalarField lambda_ =
|
||||
(4.0/3.0)*sqr(alpha_)*rhoa_*da_*gs0_*(1.0+e_)*ThetaSqrt/sqrtPi;
|
||||
lambda_ = (4.0/3.0)*sqr(alpha_)*rhoa_*da_*gs0_*(1.0+e_)*ThetaSqrt/sqrtPi;
|
||||
|
||||
|
||||
// stress tensor, Definitions, Table 3.1, p. 43
|
||||
@ -352,8 +350,7 @@ void Foam::kineticTheoryModel::solve()
|
||||
mua_.min(1.0e+2);
|
||||
mua_.max(0.0);
|
||||
|
||||
lambda_ = (4.0/3.0)*sqr(alpha_)*rhoa_*da_*gs0_*(1.0 + e_)
|
||||
*ThetaSqrt/sqrtPi;
|
||||
lambda_ = (4.0/3.0)*sqr(alpha_)*rhoa_*da_*gs0_*(1.0 + e_)*ThetaSqrt/sqrtPi;
|
||||
|
||||
Info<< "kinTheory: max(Theta) = " << max(Theta_).value() << endl;
|
||||
|
||||
|
||||
@ -107,11 +107,12 @@ int main(int argc, char *argv[])
|
||||
*mag(U.boundaryField()[patchi].snGrad())
|
||||
)
|
||||
/sgsModel->nu().boundaryField()[patchi];
|
||||
const scalarField& Yp = yPlus.boundaryField()[patchi];
|
||||
|
||||
Info<< "Patch " << patchi
|
||||
<< " named " << currPatch.name()
|
||||
<< " y+ : min: " << min(yPlus) << " max: " << max(yPlus)
|
||||
<< " average: " << average(yPlus) << nl << endl;
|
||||
<< " y+ : min: " << min(Yp) << " max: " << max(Yp)
|
||||
<< " average: " << average(Yp) << nl << endl;
|
||||
}
|
||||
}
|
||||
|
||||
|
||||
@ -49,20 +49,20 @@ bool validTri(const triSurface& surf, const label faceI)
|
||||
|| (f[2] < 0) || (f[2] >= surf.points().size())
|
||||
)
|
||||
{
|
||||
WarningIn("validTri(const triSurface&, const label)")
|
||||
<< "triangle " << faceI << " vertices " << f
|
||||
<< " uses point indices outside point range 0.."
|
||||
<< surf.points().size()-1 << endl;
|
||||
//WarningIn("validTri(const triSurface&, const label)")
|
||||
// << "triangle " << faceI << " vertices " << f
|
||||
// << " uses point indices outside point range 0.."
|
||||
// << surf.points().size()-1 << endl;
|
||||
|
||||
return false;
|
||||
}
|
||||
|
||||
if ((f[0] == f[1]) || (f[0] == f[2]) || (f[1] == f[2]))
|
||||
{
|
||||
WarningIn("validTri(const triSurface&, const label)")
|
||||
<< "triangle " << faceI
|
||||
<< " uses non-unique vertices " << f
|
||||
<< endl;
|
||||
//WarningIn("validTri(const triSurface&, const label)")
|
||||
// << "triangle " << faceI
|
||||
// << " uses non-unique vertices " << f
|
||||
// << endl;
|
||||
return false;
|
||||
}
|
||||
|
||||
@ -91,11 +91,11 @@ bool validTri(const triSurface& surf, const label faceI)
|
||||
&& ((f[2] == nbrF[0]) || (f[2] == nbrF[1]) || (f[2] == nbrF[2]))
|
||||
)
|
||||
{
|
||||
WarningIn("validTri(const triSurface&, const label)")
|
||||
<< "triangle " << faceI << " vertices " << f
|
||||
<< " has the same vertices as triangle " << nbrFaceI
|
||||
<< " vertices " << nbrF
|
||||
<< endl;
|
||||
//WarningIn("validTri(const triSurface&, const label)")
|
||||
// << "triangle " << faceI << " vertices " << f
|
||||
// << " has the same vertices as triangle " << nbrFaceI
|
||||
// << " vertices " << nbrF
|
||||
// << endl;
|
||||
|
||||
return false;
|
||||
}
|
||||
@ -270,9 +270,9 @@ int main(int argc, char *argv[])
|
||||
|
||||
if (f[0] == f[1] || f[0] == f[2] || f[1] == f[2])
|
||||
{
|
||||
WarningIn(args.executable())
|
||||
<< "Illegal triangle " << faceI << " vertices " << f
|
||||
<< " coords " << f.points(surf.points()) << endl;
|
||||
//WarningIn(args.executable())
|
||||
// << "Illegal triangle " << faceI << " vertices " << f
|
||||
// << " coords " << f.points(surf.points()) << endl;
|
||||
}
|
||||
else
|
||||
{
|
||||
|
||||
@ -1072,7 +1072,7 @@ const Foam::globalMeshData& Foam::polyMesh::globalData() const
|
||||
// Remove all files and some subdirs (eg, sets)
|
||||
void Foam::polyMesh::removeFiles(const fileName& instanceDir) const
|
||||
{
|
||||
fileName meshFilesPath = db().path()/instanceDir/meshSubDir;
|
||||
fileName meshFilesPath = db().path()/instanceDir/meshDir();
|
||||
|
||||
rm(meshFilesPath/"points");
|
||||
rm(meshFilesPath/"faces");
|
||||
|
||||
@ -13,10 +13,10 @@ sampledSet/sampledSets/sampledSets.C
|
||||
sampledSet/sampledSetsFunctionObject/sampledSetsFunctionObject.C
|
||||
|
||||
sampledSet/writers/writer/writers.C
|
||||
sampledSet/writers/raw/rawWriters.C
|
||||
sampledSet/writers/xmgr/xmgrWriters.C
|
||||
sampledSet/writers/gnuplot/gnuplotWriters.C
|
||||
sampledSet/writers/jplot/jplotWriters.C
|
||||
sampledSet/writers/raw/rawWriters.C
|
||||
|
||||
cuttingPlane/cuttingPlane.C
|
||||
|
||||
|
||||
@ -63,15 +63,13 @@ public:
|
||||
//- Construct null
|
||||
gnuplot();
|
||||
|
||||
// Destructor
|
||||
|
||||
//- Destructor
|
||||
virtual ~gnuplot();
|
||||
|
||||
|
||||
// Member Functions
|
||||
|
||||
// Write
|
||||
|
||||
virtual fileName getFileName
|
||||
(
|
||||
const coordSet&,
|
||||
|
||||
@ -22,8 +22,6 @@ License
|
||||
along with OpenFOAM; if not, write to the Free Software Foundation,
|
||||
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
||||
|
||||
Description
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#include "gnuplotWriters.H"
|
||||
@ -33,13 +31,7 @@ Description
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
|
||||
|
||||
makeWriters(gnuplot);
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWriters(gnuplot)
|
||||
}
|
||||
|
||||
// ************************************************************************* //
|
||||
|
||||
@ -25,12 +25,9 @@ License
|
||||
InClass
|
||||
Foam::gnuplotWriters
|
||||
|
||||
Description
|
||||
|
||||
SourceFiles
|
||||
gnuplotWriters.C
|
||||
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#ifndef gnuplotWriters_H
|
||||
@ -44,16 +41,8 @@ SourceFiles
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
typedef gnuplot<scalar> gnuplotScalarWriter;
|
||||
typedef gnuplot<vector> gnuplotVectorWriter;
|
||||
typedef gnuplot<tensor> gnuplotTensorWriter;
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWritersTypedefs(gnuplot)
|
||||
}
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
|
||||
@ -25,8 +25,6 @@ License
|
||||
Class
|
||||
Foam::jplot
|
||||
|
||||
Description
|
||||
|
||||
SourceFiles
|
||||
jplot.C
|
||||
|
||||
@ -43,8 +41,6 @@ SourceFiles
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// Forward declaration of classes
|
||||
|
||||
/*---------------------------------------------------------------------------*\
|
||||
Class jplot Declaration
|
||||
\*---------------------------------------------------------------------------*/
|
||||
@ -71,17 +67,13 @@ public:
|
||||
//- Construct null
|
||||
jplot();
|
||||
|
||||
// Destructor
|
||||
|
||||
//- Destructor
|
||||
virtual ~jplot();
|
||||
|
||||
|
||||
// Member Functions
|
||||
|
||||
// Access
|
||||
|
||||
// Write
|
||||
|
||||
virtual fileName getFileName
|
||||
(
|
||||
const coordSet&,
|
||||
|
||||
@ -22,8 +22,6 @@ License
|
||||
along with OpenFOAM; if not, write to the Free Software Foundation,
|
||||
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
||||
|
||||
Description
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#include "jplotWriters.H"
|
||||
@ -33,13 +31,7 @@ Description
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
|
||||
|
||||
makeWriters(jplot);
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWriters(jplot)
|
||||
}
|
||||
|
||||
// ************************************************************************* //
|
||||
|
||||
@ -25,12 +25,9 @@ License
|
||||
InClass
|
||||
Foam::jplotWriters
|
||||
|
||||
Description
|
||||
|
||||
SourceFiles
|
||||
jplotWriters.C
|
||||
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#ifndef jplotWriters_H
|
||||
@ -44,16 +41,8 @@ SourceFiles
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
typedef jplot<scalar> jplotScalarWriter;
|
||||
typedef jplot<vector> jplotVectorWriter;
|
||||
typedef jplot<tensor> jplotTensorWriter;
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWritersTypedefs(jplot)
|
||||
}
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
|
||||
@ -64,15 +64,12 @@ public:
|
||||
raw();
|
||||
|
||||
|
||||
// Destructor
|
||||
|
||||
//- Destructor
|
||||
virtual ~raw();
|
||||
|
||||
|
||||
// Member Functions
|
||||
|
||||
// Write
|
||||
|
||||
virtual fileName getFileName
|
||||
(
|
||||
const coordSet&,
|
||||
|
||||
@ -22,8 +22,6 @@ License
|
||||
along with OpenFOAM; if not, write to the Free Software Foundation,
|
||||
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
||||
|
||||
Description
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#include "rawWriters.H"
|
||||
@ -33,13 +31,7 @@ Description
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
|
||||
|
||||
makeWriters(raw);
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWriters(raw)
|
||||
}
|
||||
|
||||
// ************************************************************************* //
|
||||
|
||||
@ -25,12 +25,9 @@ License
|
||||
InClass
|
||||
Foam::rawWriters
|
||||
|
||||
Description
|
||||
|
||||
SourceFiles
|
||||
rawWriters.C
|
||||
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#ifndef rawWriters_H
|
||||
@ -44,16 +41,8 @@ SourceFiles
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
typedef raw<scalar> rawScalarWriter;
|
||||
typedef raw<vector> rawVectorWriter;
|
||||
typedef raw<tensor> rawTensorWriter;
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWritersTypedefs(raw)
|
||||
}
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
|
||||
@ -31,11 +31,11 @@ License
|
||||
|
||||
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
template<class Type>
|
||||
autoPtr<writer<Type> > writer<Type>::New(const word& writeType)
|
||||
Foam::autoPtr<Foam::writer<Type> > Foam::writer<Type>::New
|
||||
(
|
||||
const word& writeType
|
||||
)
|
||||
{
|
||||
typename wordConstructorTable::iterator cstrIter =
|
||||
wordConstructorTablePtr_
|
||||
@ -60,7 +60,7 @@ autoPtr<writer<Type> > writer<Type>::New(const word& writeType)
|
||||
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
|
||||
|
||||
template<class Type>
|
||||
fileName writer<Type>::getBaseName
|
||||
Foam::fileName Foam::writer<Type>::getBaseName
|
||||
(
|
||||
const coordSet& points,
|
||||
const wordList& valueSets
|
||||
@ -78,7 +78,7 @@ fileName writer<Type>::getBaseName
|
||||
|
||||
|
||||
template<class Type>
|
||||
void writer<Type>::writeCoord
|
||||
void Foam::writer<Type>::writeCoord
|
||||
(
|
||||
const coordSet& points,
|
||||
const label pointI,
|
||||
@ -97,7 +97,7 @@ void writer<Type>::writeCoord
|
||||
|
||||
|
||||
template<class Type>
|
||||
void writer<Type>::writeTable
|
||||
void Foam::writer<Type>::writeTable
|
||||
(
|
||||
const coordSet& points,
|
||||
const List<Type>& values,
|
||||
@ -109,16 +109,14 @@ void writer<Type>::writeTable
|
||||
writeCoord(points, pointI, os);
|
||||
|
||||
os << token::SPACE;
|
||||
|
||||
write(values[pointI], os);
|
||||
|
||||
os << endl;
|
||||
}
|
||||
}
|
||||
|
||||
|
||||
template<class Type>
|
||||
void writer<Type>::writeTable
|
||||
void Foam::writer<Type>::writeTable
|
||||
(
|
||||
const coordSet& points,
|
||||
const List<const List<Type>*>& valuesPtrList,
|
||||
@ -132,9 +130,7 @@ void writer<Type>::writeTable
|
||||
forAll(valuesPtrList, i)
|
||||
{
|
||||
os << token::SPACE;
|
||||
|
||||
const List<Type>& values = *valuesPtrList[i];
|
||||
|
||||
write(values[pointI], os);
|
||||
}
|
||||
os << endl;
|
||||
@ -144,36 +140,44 @@ void writer<Type>::writeTable
|
||||
|
||||
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
|
||||
|
||||
// Construct null
|
||||
template<class Type>
|
||||
writer<Type>::writer()
|
||||
Foam::writer<Type>::writer()
|
||||
{}
|
||||
|
||||
|
||||
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
|
||||
|
||||
template<class Type>
|
||||
writer<Type>::~writer()
|
||||
Foam::writer<Type>::~writer()
|
||||
{}
|
||||
|
||||
|
||||
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
|
||||
|
||||
template<class Type>
|
||||
Foam::Ostream& Foam::writer<Type>::write(const scalar value, Ostream& os) const
|
||||
Foam::Ostream& Foam::writer<Type>::write
|
||||
(
|
||||
const scalar value,
|
||||
Ostream& os
|
||||
) const
|
||||
{
|
||||
return os << value;
|
||||
}
|
||||
|
||||
|
||||
template<class Type>
|
||||
Foam::Ostream& Foam::writer<Type>::write(const vector& value, Ostream& os) const
|
||||
template<class VSType>
|
||||
Foam::Ostream& Foam::writer<Type>::writeVS
|
||||
(
|
||||
const VSType& value,
|
||||
Ostream& os
|
||||
) const
|
||||
{
|
||||
for (direction d=0; d<vector::nComponents; d++)
|
||||
for (direction d=0; d<VSType::nComponents; d++)
|
||||
{
|
||||
os << value.component(d);
|
||||
|
||||
if (d <= vector::nComponents-1)
|
||||
if (d <= VSType::nComponents-1)
|
||||
{
|
||||
os << token::TAB;
|
||||
}
|
||||
@ -183,23 +187,47 @@ Foam::Ostream& Foam::writer<Type>::write(const vector& value, Ostream& os) const
|
||||
|
||||
|
||||
template<class Type>
|
||||
Foam::Ostream& Foam::writer<Type>::write(const tensor& value, Ostream& os) const
|
||||
Foam::Ostream& Foam::writer<Type>::write
|
||||
(
|
||||
const vector& value,
|
||||
Ostream& os
|
||||
) const
|
||||
{
|
||||
for (direction d=0; d<tensor::nComponents; d++)
|
||||
{
|
||||
os << value.component(d);
|
||||
|
||||
if (d <= tensor::nComponents-1)
|
||||
{
|
||||
os << token::TAB;
|
||||
}
|
||||
}
|
||||
return os;
|
||||
return writeVS(value, os);
|
||||
}
|
||||
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
template<class Type>
|
||||
Foam::Ostream& Foam::writer<Type>::write
|
||||
(
|
||||
const sphericalTensor& value,
|
||||
Ostream& os
|
||||
) const
|
||||
{
|
||||
return writeVS(value, os);
|
||||
}
|
||||
|
||||
|
||||
template<class Type>
|
||||
Foam::Ostream& Foam::writer<Type>::write
|
||||
(
|
||||
const symmTensor& value,
|
||||
Ostream& os
|
||||
) const
|
||||
{
|
||||
return writeVS(value, os);
|
||||
}
|
||||
|
||||
|
||||
template<class Type>
|
||||
Foam::Ostream& Foam::writer<Type>::write
|
||||
(
|
||||
const tensor& value,
|
||||
Ostream& os
|
||||
) const
|
||||
{
|
||||
return writeVS(value, os);
|
||||
}
|
||||
|
||||
} // End namespace Foam
|
||||
|
||||
// ************************************************************************* //
|
||||
|
||||
@ -29,8 +29,8 @@ Description
|
||||
Base class for graphics format writing. Entry points are
|
||||
- write(..). \n
|
||||
Write to an Ostream a table of points with corresponding values.
|
||||
- write(scalar/vector/tensor). \n
|
||||
Write single scalar/vector/tensor.
|
||||
- write(scalar/vector/sphericalTensor/symmTensor/tensor). \n
|
||||
Write single scalar/vector/sphericalTensor/symmTensor/tensor.
|
||||
Default is to write space separated components.
|
||||
|
||||
Example:
|
||||
@ -151,17 +151,12 @@ public:
|
||||
writer();
|
||||
|
||||
|
||||
// Destructor
|
||||
|
||||
//- Destructor
|
||||
virtual ~writer() = 0;
|
||||
|
||||
|
||||
// Member Functions
|
||||
|
||||
// Access
|
||||
|
||||
// Write
|
||||
|
||||
//- Generate file name with correct extension
|
||||
virtual fileName getFileName
|
||||
(
|
||||
@ -183,9 +178,18 @@ public:
|
||||
//- Write scalar as ascii
|
||||
virtual Ostream& write(const scalar, Ostream&) const;
|
||||
|
||||
template<class VSType>
|
||||
Ostream& writeVS(const VSType& value, Ostream& os) const;
|
||||
|
||||
//- Write vector. Tab separated ascii
|
||||
virtual Ostream& write(const vector&, Ostream&) const;
|
||||
|
||||
//- Write sphericalTensor. Tab separated ascii
|
||||
virtual Ostream& write(const sphericalTensor&, Ostream&) const;
|
||||
|
||||
//- Write symmTensor. Tab separated ascii
|
||||
virtual Ostream& write(const symmTensor&, Ostream&) const;
|
||||
|
||||
//- Write tensor. Tab separated ascii
|
||||
virtual Ostream& write(const tensor&, Ostream&) const;
|
||||
};
|
||||
@ -211,6 +215,8 @@ defineNamedTemplateTypeNameAndDebug(type, 0);
|
||||
\
|
||||
makeTypeWritersTypeName(typeWriter##ScalarWriter); \
|
||||
makeTypeWritersTypeName(typeWriter##VectorWriter); \
|
||||
makeTypeWritersTypeName(typeWriter##SphericalTensorWriter); \
|
||||
makeTypeWritersTypeName(typeWriter##SymmTensorWriter); \
|
||||
makeTypeWritersTypeName(typeWriter##TensorWriter);
|
||||
|
||||
// Define type info for single template instantiation (e.g. vector)
|
||||
@ -227,9 +233,20 @@ addToRunTimeSelectionTable \
|
||||
// Define type info info for scalar, vector etc. instantiations
|
||||
#define makeWriters(typeWriter) \
|
||||
\
|
||||
makeWriterTypes(scalarWriter, typeWriter##ScalarWriter); \
|
||||
makeWriterTypes(vectorWriter, typeWriter##VectorWriter); \
|
||||
makeWriterTypes(tensorWriter, typeWriter##TensorWriter);
|
||||
makeWriterTypes(writerScalarWriter, typeWriter##ScalarWriter); \
|
||||
makeWriterTypes(writerVectorWriter, typeWriter##VectorWriter); \
|
||||
makeWriterTypes(writerSphericalTensorWriter, typeWriter##SphericalTensorWriter);\
|
||||
makeWriterTypes(writerSymmTensorWriter, typeWriter##SymmTensorWriter); \
|
||||
makeWriterTypes(writerTensorWriter, typeWriter##TensorWriter);
|
||||
|
||||
|
||||
#define makeWritersTypedefs(typeWriter) \
|
||||
\
|
||||
typedef typeWriter<scalar> typeWriter##ScalarWriter; \
|
||||
typedef typeWriter<vector> typeWriter##VectorWriter; \
|
||||
typedef typeWriter<sphericalTensor> typeWriter##SphericalTensorWriter; \
|
||||
typedef typeWriter<symmTensor> typeWriter##SymmTensorWriter; \
|
||||
typedef typeWriter<tensor> typeWriter##TensorWriter;
|
||||
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
@ -22,8 +22,6 @@ License
|
||||
along with OpenFOAM; if not, write to the Free Software Foundation,
|
||||
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
||||
|
||||
Description
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#include "writers.H"
|
||||
@ -35,20 +33,20 @@ namespace Foam
|
||||
|
||||
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
|
||||
|
||||
defineNamedTemplateTypeNameAndDebug(scalarWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(scalarWriter, word);
|
||||
defineNamedTemplateTypeNameAndDebug(writerScalarWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(writerScalarWriter, word);
|
||||
|
||||
defineNamedTemplateTypeNameAndDebug(vectorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(vectorWriter, word);
|
||||
defineNamedTemplateTypeNameAndDebug(writerVectorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(writerVectorWriter, word);
|
||||
|
||||
defineNamedTemplateTypeNameAndDebug(sphericalTensorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(sphericalTensorWriter, word);
|
||||
defineNamedTemplateTypeNameAndDebug(writerSphericalTensorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(writerSphericalTensorWriter, word);
|
||||
|
||||
defineNamedTemplateTypeNameAndDebug(symmTensorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(symmTensorWriter, word);
|
||||
defineNamedTemplateTypeNameAndDebug(writerSymmTensorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(writerSymmTensorWriter, word);
|
||||
|
||||
defineNamedTemplateTypeNameAndDebug(tensorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(tensorWriter, word);
|
||||
defineNamedTemplateTypeNameAndDebug(writerTensorWriter, 0);
|
||||
defineTemplateRunTimeSelectionTable(writerTensorWriter, word);
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
|
||||
@ -23,9 +23,10 @@ License
|
||||
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
||||
|
||||
InClass
|
||||
Foam::writer
|
||||
Foam::rawWriters
|
||||
|
||||
Description
|
||||
SourceFiles
|
||||
writers.C
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
@ -39,18 +40,8 @@ Description
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
typedef writer<scalar> scalarWriter;
|
||||
typedef writer<vector> vectorWriter;
|
||||
typedef writer<sphericalTensor> sphericalTensorWriter;
|
||||
typedef writer<symmTensor> symmTensorWriter;
|
||||
typedef writer<tensor> tensorWriter;
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWritersTypedefs(writer)
|
||||
}
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
|
||||
@ -63,15 +63,13 @@ public:
|
||||
//- Construct null
|
||||
xmgr();
|
||||
|
||||
// Destructor
|
||||
|
||||
//- Destructor
|
||||
virtual ~xmgr();
|
||||
|
||||
|
||||
// Member Functions
|
||||
|
||||
// Write
|
||||
|
||||
virtual fileName getFileName
|
||||
(
|
||||
const coordSet&,
|
||||
|
||||
@ -22,8 +22,6 @@ License
|
||||
along with OpenFOAM; if not, write to the Free Software Foundation,
|
||||
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
|
||||
|
||||
Description
|
||||
|
||||
\*---------------------------------------------------------------------------*/
|
||||
|
||||
#include "xmgrWriters.H"
|
||||
@ -33,13 +31,7 @@ Description
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
|
||||
|
||||
makeWriters(xmgr);
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWriters(xmgr)
|
||||
}
|
||||
|
||||
// ************************************************************************* //
|
||||
|
||||
@ -44,16 +44,8 @@ SourceFiles
|
||||
|
||||
namespace Foam
|
||||
{
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
typedef xmgr<scalar> xmgrScalarWriter;
|
||||
typedef xmgr<vector> xmgrVectorWriter;
|
||||
typedef xmgr<tensor> xmgrTensorWriter;
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
} // End namespace Foam
|
||||
makeWritersTypedefs(xmgr)
|
||||
}
|
||||
|
||||
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
|
||||
|
||||
|
||||
@ -16,7 +16,7 @@ FoamFile
|
||||
|
||||
dimensions [0 2 -2 0 0 0 0];
|
||||
|
||||
internalField uniform 0;
|
||||
internalField uniform 2e-05;
|
||||
|
||||
boundaryField
|
||||
{
|
||||
@ -36,13 +36,13 @@ boundaryField
|
||||
upperWall
|
||||
{
|
||||
type fixedValue;
|
||||
value uniform 0;
|
||||
value uniform 1e-8;
|
||||
}
|
||||
|
||||
lowerWall
|
||||
{
|
||||
type fixedValue;
|
||||
value uniform 0;
|
||||
value uniform 1e-8;
|
||||
}
|
||||
|
||||
frontAndBack
|
||||
|
||||
Reference in New Issue
Block a user