Merge branch 'master' of /home/dm4/OpenFOAM/OpenFOAM-dev

This commit is contained in:
mattijs
2012-07-24 21:29:58 +01:00
19 changed files with 70 additions and 129 deletions

View File

@ -128,10 +128,14 @@ greyDiffusiveViewFactorFixedValueFvPatchScalarField
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void Foam::radiation::greyDiffusiveViewFactorFixedValueFvPatchScalarField:: void Foam::radiation::greyDiffusiveViewFactorFixedValueFvPatchScalarField::
updateCoeffs() updateCoeffs()
{ {
if (this->updated())
{
return;
}
// Do nothing // Do nothing
if (debug) if (debug)
@ -149,6 +153,7 @@ updateCoeffs()
<< endl; << endl;
} }
fixedValueFvPatchScalarField::updateCoeffs();
} }

View File

@ -142,6 +142,8 @@ void convectiveHeatTransferFvPatchScalarField::updateCoeffs()
htc[faceI] = 0.037*pow(Re, 0.8)*cbrt(Pr[faceI])*kappaw[faceI]/L_; htc[faceI] = 0.037*pow(Re, 0.8)*cbrt(Pr[faceI])*kappaw[faceI]/L_;
} }
} }
fixedValueFvPatchScalarField::updateCoeffs();
} }

View File

@ -116,7 +116,8 @@ atmBoundaryLayerInletEpsilonFvPatchScalarField
z_ /= mag(z_); z_ /= mag(z_);
evaluate(); const vectorField& c = patch().Cf();
scalarField::operator=(pow3(Ustar_)/(kappa_*((c & z_) - zGround_ + z0_)));
} }
@ -169,14 +170,6 @@ void atmBoundaryLayerInletEpsilonFvPatchScalarField::rmap
} }
void atmBoundaryLayerInletEpsilonFvPatchScalarField::updateCoeffs()
{
const vectorField& c = patch().Cf();
tmp<scalarField> coord = (c & z_);
scalarField::operator=(pow3(Ustar_)/(kappa_*(coord - zGround_ + z0_)));
}
void atmBoundaryLayerInletEpsilonFvPatchScalarField::write(Ostream& os) const void atmBoundaryLayerInletEpsilonFvPatchScalarField::write(Ostream& os) const
{ {
fvPatchScalarField::write(os); fvPatchScalarField::write(os);

View File

@ -176,7 +176,7 @@ public:
// Access // Access
//- Return max value //- Return max value
scalarField Ustar() const const scalarField& Ustar() const
{ {
return Ustar_; return Ustar_;
} }
@ -204,12 +204,6 @@ public:
); );
// Evaluation functions
//- Update coefficients
virtual void updateCoeffs();
//- Write //- Write
virtual void write(Ostream&) const; virtual void write(Ostream&) const;
}; };

View File

@ -120,7 +120,25 @@ atmBoundaryLayerInletVelocityFvPatchVectorField
Ustar_[i] = kappa_*Uref_/(log((Href_ + z0_[i])/max(z0_[i] , 0.001))); Ustar_[i] = kappa_*Uref_/(log((Href_ + z0_[i])/max(z0_[i] , 0.001)));
} }
evaluate(); const vectorField& c = patch().Cf();
const scalarField coord(c & z_);
scalarField Un(coord.size());
forAll(coord, i)
{
if ((coord[i] - zGround_[i]) < Href_)
{
Un[i] =
(Ustar_[i]/kappa_)
* log((coord[i] - zGround_[i] + z0_[i])/max(z0_[i], 0.001));
}
else
{
Un[i] = Uref_;
}
}
vectorField::operator=(n_*Un);
} }
@ -174,32 +192,6 @@ void atmBoundaryLayerInletVelocityFvPatchVectorField::rmap
} }
void atmBoundaryLayerInletVelocityFvPatchVectorField::updateCoeffs()
{
const vectorField& c = patch().Cf();
const scalarField coord(c & z_);
scalarField Un(coord.size());
forAll(coord, i)
{
if ((coord[i] - zGround_[i]) < Href_)
{
Un[i] =
(Ustar_[i]/kappa_)
* log((coord[i] - zGround_[i] + z0_[i])/max(z0_[i], 0.001));
}
else
{
Un[i] = Uref_;
}
}
vectorField::operator=(n_*Un);
fixedValueFvPatchVectorField::updateCoeffs();
}
void atmBoundaryLayerInletVelocityFvPatchVectorField::write(Ostream& os) const void atmBoundaryLayerInletVelocityFvPatchVectorField::write(Ostream& os) const
{ {
fvPatchVectorField::write(os); fvPatchVectorField::write(os);

View File

@ -180,23 +180,26 @@ public:
// Member functions // Member functions
//- Return Ustar // Access
scalarField& Ustar()
{
return Ustar_;
}
//- Return flow direction //- Return Ustar
vector& n() const scalarField& Ustar() const
{ {
return n_; return Ustar_;
} }
//- Return flow direction
const vector& n() const
{
return n_;
}
//- Return z direction
const vector& z() const
{
return z_;
}
//- Return z direction
vector& z()
{
return z_;
}
// Mapping functions // Mapping functions
@ -214,12 +217,6 @@ public:
); );
// Evaluation functions
//- Update coefficients
virtual void updateCoeffs();
//- Write //- Write
virtual void write(Ostream&) const; virtual void write(Ostream&) const;
}; };

View File

@ -24,6 +24,7 @@ boundaryField
ground ground
{ {
type alphatWallFunction; type alphatWallFunction;
mut muSgs;
value uniform 0; value uniform 0;
} }
@ -45,6 +46,7 @@ boundaryField
"(region0_to.*)" "(region0_to.*)"
{ {
type alphatWallFunction; type alphatWallFunction;
mut muSgs;
value uniform 0; value uniform 0;
} }
} }

View File

@ -15,7 +15,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
combustionModel infinitelyFastChemistry<psiCombustionModel,gasThermoPhysics>; combustionModel infinitelyFastChemistry<psiThermoCombustion,gasThermoPhysics>;
active true; active true;

View File

@ -32,7 +32,7 @@ solvers
relTol 0; relTol 0;
} }
"rho|rhot" rhoThermo
{ {
solver PCG; solver PCG;
preconditioner DIC; preconditioner DIC;

View File

@ -15,9 +15,9 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
//combustionModel noCombustion<psiCombustionModel>; //combustionModel noCombustion<psiThermoCombustion>;
combustionModel infinitelyFastChemistry<psiCombustionModel,gasThermoPhysics>; combustionModel infinitelyFastChemistry<psiThermoCombustion,gasThermoPhysics>;
//combustionModel FSD<psiCombustionModel,gasThermoPhysics>; //combustionModel FSD<psiThermoCombustion,gasThermoPhysics>;
active true; active true;

View File

@ -16,7 +16,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
combustionModel infinitelyFastChemistry<psiCombustionModel,gasThermoPhysics>; combustionModel infinitelyFastChemistry<psiThermoCombustion,gasThermoPhysics>;
active on; active on;

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format binary; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh"; location "constant/polyMesh";
object boundary; object boundary;

View File

@ -15,7 +15,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
thermoType hePsiThermo<pureMixture<sutherlandTransport<specieThermo<eConstThermo<perfectGas>,sensibleInternalEnergy>>>>; thermoType heRhoThermo<pureMixture<sutherlandTransport<specieThermo<hConstThermo<perfectGas>,sensibleInternalEnergy>>>>;
mixture mixture
{ {
@ -26,7 +26,7 @@ mixture
} }
thermodynamics thermodynamics
{ {
Cv 719.3; Cp 1005;
Hf 0; Hf 0;
} }
transport transport

View File

@ -15,7 +15,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
thermoType hePsiThermo<pureMixture<sutherlandTransport<specieThermo<eConstThermo<perfectGas>,sensibleInternalEnergy>>>>; thermoType hePsiThermo<pureMixture<sutherlandTransport<specieThermo<hConstThermo<perfectGas>,sensibleInternalEnergy>>>>;
mixture mixture
{ {
@ -26,7 +26,7 @@ mixture
} }
thermodynamics thermodynamics
{ {
Cv 719.3; Cp 1007;
Hf 0; Hf 0;
} }
transport transport

View File

@ -15,7 +15,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
thermoType hePsiThermo<pureMixture<constTransport<specieThermo<eConstThermo<perfectGas>,sensibleInternalEnergy>>>>; thermoType hePsiThermo<pureMixture<constTransport<specieThermo<hConstThermo<perfectGas>,sensibleInternalEnergy>>>>;
mixture mixture
{ {
@ -26,7 +26,7 @@ mixture
} }
thermodynamics thermodynamics
{ {
Cv 717.5; Cp 1005;
Hf 0; Hf 0;
} }
transport transport

View File

@ -15,7 +15,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
thermoType hePsiThermo<pureMixture<constTransport<specieThermo<eConstThermo<perfectGas>,sensibleInternalEnergy>>>>; thermoType hePsiThermo<pureMixture<constTransport<specieThermo<hConstThermo<perfectGas>,sensibleInternalEnergy>>>>;
mixture mixture
{ {
@ -26,7 +26,7 @@ mixture
} }
thermodynamics thermodynamics
{ {
Cv 717.5; Cp 1005;
Hf 0; Hf 0;
} }
transport transport

View File

@ -15,7 +15,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
thermoType hePsiThermo<pureMixture<constTransport<specieThermo<eConstThermo<perfectGas>,sensibleInternalEnergy>>>>; thermoType hePsiThermo<pureMixture<constTransport<specieThermo<hConstThermo<perfectGas>,sensibleInternalEnergy>>>>;
mixture mixture
{ {
@ -26,7 +26,7 @@ mixture
} }
thermodynamics thermodynamics
{ {
Cv 717.5; Cp 1005;
Hf 0; Hf 0;
} }
transport transport

View File

@ -1,42 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
object changeDictionaryDict;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dictionaryReplacement
{
boundary
{
AMI1
{
type cyclicAMI;
neighbourPatch AMI2;
transform noOrdering;
surface
{
}
}
AMI2
{
type cyclicAMI;
neighbourPatch AMI1;
transform noOrdering;
surface
{
}
}
}
}
// ************************************************************************* //

View File

@ -16,20 +16,18 @@ FoamFile
ddtSchemes ddtSchemes
{ {
default steadyState; default steadyState;
} }
gradSchemes gradSchemes
{ {
default Gauss linear; default Gauss linear;
grad(p) Gauss linear;
grad(U) Gauss linear;
} }
divSchemes divSchemes
{ {
default none; default none;
div(phi,U) Gauss upwind grad(U); div(phi,U) Gauss upwind;
div((nuEff*dev(T(grad(U))))) Gauss linear; div((nuEff*dev(T(grad(U))))) Gauss linear;
div(phi,epsilon) Gauss upwind; div(phi,epsilon) Gauss upwind;
div(phi,k) Gauss upwind; div(phi,k) Gauss upwind;