Merge branch 'master' of ssh://noisy/home/noisy3/OpenFOAM/OpenFOAM-dev

This commit is contained in:
sergio
2011-06-03 13:45:41 +01:00
16 changed files with 42 additions and 50 deletions

View File

@ -43,10 +43,10 @@ EXE_LIBS = \
-lmeshTools \ -lmeshTools \
-lmolecularMeasurements \ -lmolecularMeasurements \
-lmolecule \ -lmolecule \
-lmultiphaseInterFoam \ /* -lmultiphaseInterFoam */ \
-lODE \ -lODE \
-lOpenFOAM \ -lOpenFOAM \
-lphaseModel \ /* -lphaseModel */ \
-lpotential \ -lpotential \
-lradiationModels \ -lradiationModels \
-lrandomProcesses \ -lrandomProcesses \

View File

@ -44,13 +44,10 @@ void Foam::cyclicFvPatch::makeWeights(scalarField& w) const
{ {
const cyclicFvPatch& nbrPatch = neighbFvPatch(); const cyclicFvPatch& nbrPatch = neighbFvPatch();
const scalarField& magFa = magSf();
const scalarField& nbrMagFa = nbrPatch.magSf();
const scalarField deltas(nf() & fvPatch::delta()); const scalarField deltas(nf() & fvPatch::delta());
const scalarField nbrDeltas(nbrPatch.nf() & nbrPatch.fvPatch::delta()); const scalarField nbrDeltas(nbrPatch.nf() & nbrPatch.fvPatch::delta());
forAll(magFa, facei) forAll(deltas, facei)
{ {
scalar di = deltas[facei]; scalar di = deltas[facei];
scalar dni = nbrDeltas[facei]; scalar dni = nbrDeltas[facei];

View File

@ -4,6 +4,6 @@ singleLayerRegion/singleLayerRegion.C
regionModel1D/regionModel1D.C regionModel1D/regionModel1D.C
/* Boundary conditions */ /* Boundary conditions */
derivedFvPatchFields/directMappedVariableThicknessWallFvPatch.C derivedFvPatches/directMappedVariableThicknessWall/directMappedVariableThicknessWallFvPatch.C
LIB = $(FOAM_LIBBIN)/libregionModels LIB = $(FOAM_LIBBIN)/libregionModels

View File

@ -64,13 +64,12 @@ noThermo::~noThermo()
// * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * //
void noThermo::preEvolveRegion() void noThermo::preEvolveRegion()
{ {}
}
void noThermo::evolveRegion() void noThermo::evolveRegion()
{ {}
}
const tmp<volScalarField> noThermo::Cp() const const tmp<volScalarField> noThermo::Cp() const
{ {
@ -103,6 +102,7 @@ const volScalarField& noThermo::kappa() const
return volScalarField::null(); return volScalarField::null();
} }
const volScalarField& noThermo::rho() const const volScalarField& noThermo::rho() const
{ {
FatalErrorIn("const volScalarField& noThermo::rho() const") FatalErrorIn("const volScalarField& noThermo::rho() const")
@ -110,6 +110,7 @@ const volScalarField& noThermo::rho() const
return volScalarField::null(); return volScalarField::null();
} }
const volScalarField& noThermo::K() const const volScalarField& noThermo::K() const
{ {
FatalErrorIn("const volScalarField& noThermo::K() const") FatalErrorIn("const volScalarField& noThermo::K() const")
@ -117,6 +118,7 @@ const volScalarField& noThermo::K() const
return volScalarField::null(); return volScalarField::null();
} }
const volScalarField& noThermo::T() const const volScalarField& noThermo::T() const
{ {
FatalErrorIn("const volScalarField& noThermo::T() const") FatalErrorIn("const volScalarField& noThermo::T() const")

View File

@ -131,7 +131,6 @@ void thermoBaffle2D::solveEnergy()
TEqn.solve(); TEqn.solve();
thermo_->correct(); thermo_->correct();
} }
@ -217,8 +216,7 @@ thermoBaffle2D::~thermoBaffle2D()
// * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * //
void thermoBaffle2D::preEvolveRegion() void thermoBaffle2D::preEvolveRegion()
{ {}
}
void thermoBaffle2D::evolveRegion() void thermoBaffle2D::evolveRegion()
@ -229,31 +227,37 @@ void thermoBaffle2D::evolveRegion()
} }
} }
const tmp<volScalarField> thermoBaffle2D::Cp() const const tmp<volScalarField> thermoBaffle2D::Cp() const
{ {
return thermo_->Cp(); return thermo_->Cp();
} }
const volScalarField& thermoBaffle2D::kappa() const const volScalarField& thermoBaffle2D::kappa() const
{ {
return thermo_->kappa(); return thermo_->kappa();
} }
const volScalarField& thermoBaffle2D::rho() const const volScalarField& thermoBaffle2D::rho() const
{ {
return thermo_->rho(); return thermo_->rho();
} }
const volScalarField& thermoBaffle2D::K() const const volScalarField& thermoBaffle2D::K() const
{ {
return thermo_->K(); return thermo_->K();
} }
const volScalarField& thermoBaffle2D::T() const const volScalarField& thermoBaffle2D::T() const
{ {
return T_; return T_;
} }
void thermoBaffle2D::info() const void thermoBaffle2D::info() const
{ {
Info<< indent << "min/max(T) = " << min(T_).value() << ", " Info<< indent << "min/max(T) = " << min(T_).value() << ", "
@ -275,6 +279,7 @@ void thermoBaffle2D::info() const
} }
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // end namespace thermoBaffleModels } // end namespace thermoBaffleModels

View File

@ -80,6 +80,7 @@ protected:
//- Number of non orthogonal correctors //- Number of non orthogonal correctors
label nNonOrthCorr_; label nNonOrthCorr_;
// Thermo properties // Thermo properties
//- Solid thermo //- Solid thermo
@ -88,6 +89,7 @@ protected:
//- Temperature / [K] //- Temperature / [K]
volScalarField& T_; volScalarField& T_;
// Source term fields // Source term fields
//- Surface energy source / [J/m2/s] //- Surface energy source / [J/m2/s]

View File

@ -50,7 +50,7 @@ inline tmp<scalarField> thermoBaffle2D::hs
const label patchI const label patchI
) const ) const
{ {
const scalarField& Cp = thermo_->Cp()().boundaryField()[patchI]; const scalarField Cp(thermo_->Cp(patchI));
return Cp*(T - 298.15); return Cp*(T - 298.15);
} }

View File

@ -74,7 +74,7 @@ thermoBaffleModel::thermoBaffleModel(const word& modelType, const fvMesh& mesh)
{ {
const polyBoundaryMesh& rbm = regionMesh().boundaryMesh(); const polyBoundaryMesh& rbm = regionMesh().boundaryMesh();
// Check if region mesh in oneD // Check if region mesh in 1-D
label nTotalEdges = 0; label nTotalEdges = 0;
const label patchi = intCoupledPatchIDs_[0]; const label patchi = intCoupledPatchIDs_[0];
nTotalEdges = 2*nLayers_*rbm[patchi].nInternalEdges(); nTotalEdges = 2*nLayers_*rbm[patchi].nInternalEdges();
@ -113,10 +113,10 @@ thermoBaffleModel::thermoBaffleModel(const word& modelType, const fvMesh& mesh)
FatalErrorIn FatalErrorIn
( (
"thermoBaffleModel::thermoBaffleModel" "thermoBaffleModel::thermoBaffleModel"
"(\n" "("
" const word& modelType," " const word&,"
" const fvMesh& mesh" " const fvMesh&"
")\n" ")"
) << "\n patch type '" << pp.type() ) << "\n patch type '" << pp.type()
<< "' not type '" << "' not type '"
<< directMappedVariableThicknessWallPolyPatch::typeName << directMappedVariableThicknessWallPolyPatch::typeName
@ -129,10 +129,10 @@ thermoBaffleModel::thermoBaffleModel(const word& modelType, const fvMesh& mesh)
FatalErrorIn FatalErrorIn
( (
"thermoBaffleModel::thermoBaffleModel" "thermoBaffleModel::thermoBaffleModel"
"(\n" "("
" const word& modelType," " const word&,"
" const fvMesh& mesh" " const fvMesh&"
")\n" ")"
) << "\n patch type '" << pp.type() ) << "\n patch type '" << pp.type()
<< "' not type '" << "' not type '"
<< directMappedWallPolyPatch::typeName << directMappedWallPolyPatch::typeName
@ -161,8 +161,8 @@ thermoBaffleModel::thermoBaffleModel(const word& modelType, const fvMesh& mesh)
( (
"thermoBaffleModel::thermoBaffleModel" "thermoBaffleModel::thermoBaffleModel"
"(" "("
" const word& modelType," " const word&,"
" const fvMesh& mesh" " const fvMesh&"
")" ")"
) << " coupled patches in thermoBaffle are " << nl ) << " coupled patches in thermoBaffle are " << nl
<< " different sizes from list thickness" << nl << " different sizes from list thickness" << nl
@ -188,7 +188,6 @@ thermoBaffleModel::thermoBaffleModel(const word& modelType, const fvMesh& mesh)
} }
} }
} }
} }
} }
@ -202,8 +201,7 @@ thermoBaffleModel::~thermoBaffleModel()
// * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * //
void thermoBaffleModel::preEvolveRegion() void thermoBaffleModel::preEvolveRegion()
{ {}
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -173,7 +173,6 @@ public:
//- Pre-evolve region //- Pre-evolve region
virtual void preEvolveRegion(); virtual void preEvolveRegion();
}; };

View File

@ -38,8 +38,6 @@ SourceFiles
#include "ODEChemistryModel.H" #include "ODEChemistryModel.H"
#include "IOdictionary.H" #include "IOdictionary.H"
#include "scalarField.H" #include "scalarField.H"
#include "autoPtr.H"
#include "runTimeSelectionTables.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -69,21 +67,6 @@ public:
TypeName("chemistrySolver"); TypeName("chemistrySolver");
// Declare runtime constructor selection table
declareRunTimeSelectionTable
(
autoPtr,
chemistrySolver,
dictionary,
(
const fvMesh& mesh,
const word& ODEModelName,
const word& thermoType
),
(mesh, ODEModelName, thermoType)
);
// Constructors // Constructors
//- Construct from components //- Construct from components

View File

@ -9,10 +9,16 @@ rm -rf constant/polyMesh/sets
runApplication blockMesh runApplication blockMesh
runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/bottomAir.stl bottomAir runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/bottomAir.stl bottomAir
mv log.surfaceFeatureExtract log.surfaceFeatureExtract.bottom
runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/heater.stl heater runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/heater.stl heater
mv log.surfaceFeatureExtract log.surfaceFeatureExtract.heater
runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/leftSolid.stl leftSolid runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/leftSolid.stl leftSolid
mv log.surfaceFeatureExtract log.surfaceFeatureExtract.leftSolid
runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/rightSolid.stl rightSolid runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/rightSolid.stl rightSolid
mv log.surfaceFeatureExtract log.surfaceFeatureExtract.rightSolid
runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/topAir.stl topAir runApplication surfaceFeatureExtract -includedAngle 150 constant/triSurface/topAir.stl topAir
mv log.surfaceFeatureExtract log.surfaceFeatureExtract.topAir
runApplication snappyHexMesh -overwrite runApplication snappyHexMesh -overwrite
runApplication splitMeshRegions -cellZones -overwrite runApplication splitMeshRegions -cellZones -overwrite

View File

@ -299,7 +299,7 @@ meshQualityControls
// <0 = inside out tet, // <0 = inside out tet,
// 0 = flat tet // 0 = flat tet
// 1 = regular tet // 1 = regular tet
minTetQuality 1e-9; minTetQuality 1e-30;
//- Minimum face area. Set to <0 to disable. //- Minimum face area. Set to <0 to disable.
minArea -1; minArea -1;

View File

@ -292,7 +292,7 @@ meshQualityControls
// <0 = inside out tet, // <0 = inside out tet,
// 0 = flat tet // 0 = flat tet
// 1 = regular tet // 1 = regular tet
minTetQuality 1e-9; minTetQuality 1e-30;
//- Minimum face area. Set to <0 to disable. //- Minimum face area. Set to <0 to disable.
minArea -1; minArea -1;

View File

@ -320,7 +320,7 @@ meshQualityControls
// <0 = inside out tet, // <0 = inside out tet,
// 0 = flat tet // 0 = flat tet
// 1 = regular tet // 1 = regular tet
minTetQuality 1e-9; minTetQuality 1e-30;
//- Minimum face area. Set to <0 to disable. //- Minimum face area. Set to <0 to disable.
minArea -1; minArea -1;