diff options
author | 2008-03-27 00:48:33 +0000 | |
---|---|---|
committer | 2008-03-27 00:48:33 +0000 | |
commit | 4d50c3ba4cf3d6fe4adb35913de07680814df88e (patch) | |
tree | 6b66345371ea54b23c1ae83828b0215ef218cd32 /sci-libs | |
parent | sci-libs/openfoam-kernel: Move patchset to dev.ge.org (diff) | |
download | sunrise-4d50c3ba4cf3d6fe4adb35913de07680814df88e.tar.gz sunrise-4d50c3ba4cf3d6fe4adb35913de07680814df88e.tar.bz2 sunrise-4d50c3ba4cf3d6fe4adb35913de07680814df88e.zip |
sci-libs/openfoam-src: Move patchset to dev.ge.org
svn path=/sunrise/; revision=5903
Diffstat (limited to 'sci-libs')
4 files changed, 10 insertions, 1085 deletions
diff --git a/sci-libs/openfoam-src/ChangeLog b/sci-libs/openfoam-src/ChangeLog index f2a8b79b2..27b1c472b 100644 --- a/sci-libs/openfoam-src/ChangeLog +++ b/sci-libs/openfoam-src/ChangeLog @@ -3,6 +3,11 @@ # $Header: $ 27 Mar 2008; Markus Ullmann <jokey@gentoo.org> + -openfoam-src-1.4.1_p20080131.patch, + -openfoam-src-compile-1.4.1_p20080131.patch: + Move patchset to dev.ge.org + + 27 Mar 2008; Markus Ullmann <jokey@gentoo.org> -openfoam-src-1.4.1_p20080118.patch, -openfoam-src-compile-1.4.1_p20080118.patch, openfoam-src-1.4.1_p20080118: Drop old diff --git a/sci-libs/openfoam-src/files/openfoam-src-1.4.1_p20080131.patch b/sci-libs/openfoam-src/files/openfoam-src-1.4.1_p20080131.patch deleted file mode 100644 index 346405949..000000000 --- a/sci-libs/openfoam-src/files/openfoam-src-1.4.1_p20080131.patch +++ /dev/null @@ -1,851 +0,0 @@ -Index: LESmodels/compressible/SpalartAllmaras/SpalartAllmaras.C -=================================================================== ---- src/LESmodels/compressible/SpalartAllmaras/SpalartAllmaras.C (Revision 30) -+++ src/LESmodels/compressible/SpalartAllmaras/SpalartAllmaras.C (Revision 439) -@@ -44,29 +44,38 @@ - - - // * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * * // - - tmp<volScalarField> SpalartAllmaras::fv1() const - { - volScalarField chi3 = pow(nuTilda_/(mu()/rho()), 3); -- - return chi3/(chi3 + pow(Cv1_, 3)); - } - - - tmp<volScalarField> SpalartAllmaras::fv2() const - { - volScalarField chi = nuTilda_/(mu()/rho()); - return scalar(1) - chi/(scalar(1) + chi*fv1()); - } - - - tmp<volScalarField> SpalartAllmaras::fw(const volScalarField& Stilda) const - { -- volScalarField r = nuTilda_/(Stilda*sqr(kappa_*dTilda_)); -+ volScalarField r = min -+ ( -+ nuTilda_ -+ /( -+ max(Stilda, dimensionedScalar("SMALL", Stilda.dimensions(), SMALL)) -+ *sqr(kappa_*dTilda_) -+ ), -+ scalar(10.0) -+ ); -+ r.boundaryField() == 0.0; -+ - volScalarField g = r + Cw2_*(pow(r, 6) - r); - - return g*pow((1.0 + pow(Cw3_, 6))/(pow(g, 6) + pow(Cw3_, 6)), 1.0/6.0); - } - - - // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // - -Index: dynamicMesh/meshCut/meshModifiers/multiDirRefinement/multiDirRefinement.C -=================================================================== ---- src/dynamicMesh/meshCut/meshModifiers/multiDirRefinement/multiDirRefinement.C (Revision 30) -+++ src/dynamicMesh/meshCut/meshModifiers/multiDirRefinement/multiDirRefinement.C (Revision 439) -@@ -343,16 +343,16 @@ - } - } - } - - - hexRefiner.setRefinement(consistentCells, meshMod); - -- // Use inflation -- autoPtr<mapPolyMesh> morphMapPtr = meshMod.changeMesh(mesh, true, true); -+ // Change mesh, no inflation -+ autoPtr<mapPolyMesh> morphMapPtr = meshMod.changeMesh(mesh, false, true); - const mapPolyMesh& morphMap = morphMapPtr(); - - if (morphMap.hasMotionPoints()) - { - mesh.movePoints(morphMap.preMotionPoints()); - } - -@@ -365,47 +365,31 @@ - { - Pout<< "multiDirRefinement : updated mesh at time " - << mesh.time().timeName() << endl; - } - - hexRefiner.updateMesh(morphMap); - -- // Take over split pattern from hex refiner. (should be empty at this -- // point) -- -- // From old cell label to index -- Map<label> consistentSet(2*consistentCells.size()); -- -- forAll(consistentCells, i) -- { -- consistentSet.insert(consistentCells[i], i); -- } -- - // Collect all cells originating from same old cell (original + 7 extra) - -- addedCells_.setSize(consistentCells.size()); -- forAll(addedCells_, i) -+ forAll(consistentCells, i) - { -- addedCells_[i].setSize(8); -+ addedCells_[consistentCells[i]].setSize(8); - } -- labelList nAddedCells(consistentCells.size(), 0); -+ labelList nAddedCells(addedCells_.size(), 0); - - const labelList& cellMap = morphMap.cellMap(); - - forAll(cellMap, cellI) - { - label oldCellI = cellMap[cellI]; - -- Map<label>::const_iterator iter = consistentSet.find(oldCellI); -- -- if (iter != consistentSet.end()) -+ if (addedCells_[oldCellI].size() > 0) - { -- label index = iter(); -- -- addedCells_[nAddedCells[index]++] = cellI; -+ addedCells_[oldCellI][nAddedCells[oldCellI]++] = cellI; - } - } - } - - - void Foam::multiDirRefinement::refineAllDirs - ( - -Index: OpenFOAM/db/error/error.H -=================================================================== ---- src/OpenFOAM/db/error/error.H (Revision 30) -+++ src/OpenFOAM/db/error/error.H (Revision 439) -@@ -80,14 +80,17 @@ - - //- Construct from title string - error(const string& title); - - //- Construct from dictionary - error(const dictionary& errDict); - -+ //- Construct as copy -+ error(const error& err); -+ - - // Destructor - - ~error(); - - - // Member functions -Index: OpenFOAM/db/error/error.C -=================================================================== ---- src/OpenFOAM/db/error/error.C (Revision 30) -+++ src/OpenFOAM/db/error/error.C (Revision 439) -@@ -76,14 +76,28 @@ - "cannot open error stream" - << endl; - ::exit(1); - } - } - - -+error::error(const error& err) -+: -+ messageStream(err), -+ functionName_(err.functionName_), -+ sourceFileName_(err.sourceFileName_), -+ sourceFileLineNumber_(err.sourceFileLineNumber_), -+ abort_(err.abort_), -+ throwExceptions_(err.throwExceptions_), -+ messageStreamPtr_(new OStringStream(*err.messageStreamPtr_)) -+{ -+ //*messageStreamPtr_ << err.message(); -+} -+ -+ - error::~error() - { - delete messageStreamPtr_; - } - - - OSstream& error::operator() -@@ -251,14 +265,15 @@ - return os; - } - - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - // Global error definitions - --error FatalError ("--> FOAM FATAL ERROR : "); -+error FatalError("--> FOAM FATAL ERROR : "); - - // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - - } // End namespace Foam - - // ************************************************************************* // -+ -Index: OpenFOAM/db/dictionary/dictionary.C -=================================================================== ---- src/OpenFOAM/db/dictionary/dictionary.C (Revision 30) -+++ src/OpenFOAM/db/dictionary/dictionary.C (Revision 439) -@@ -119,14 +119,20 @@ - } - else - { - return -1; - } - } - -+// Clear the Dictionary -+void Foam::dictionary::clear() -+{ -+ IDLList<entry>::clear(); -+ hashedEntries_.clear(); -+} - - // Find and return entry - bool Foam::dictionary::found(const word& keyword) const - { - return hashedEntries_.found(keyword); - } - -Index: OpenFOAM/db/dictionary/dictionary.H -=================================================================== ---- src/OpenFOAM/db/dictionary/dictionary.H (Revision 30) -+++ src/OpenFOAM/db/dictionary/dictionary.H (Revision 439) -@@ -126,14 +126,16 @@ - - //- Return line number of first token in dictionary - label startLineNumber() const; - - //- Return line number of last token in dictionary - label endLineNumber() const; - -+ //- Clear the dictionary -+ void clear(); - - // Search and lookup - - //- Search dictionary for given keyword - bool found(const word& keyword) const; - - //- Find and return an entry data stream -Index: OpenFOAM/db/IOstreams/StringStreams/OStringStream.H -=================================================================== ---- src/OpenFOAM/db/IOstreams/StringStreams/OStringStream.H (Revision 30) -+++ src/OpenFOAM/db/IOstreams/StringStreams/OStringStream.H (Revision 439) -@@ -63,21 +63,41 @@ - ( - streamFormat format=ASCII, - versionNumber version=currentVersion - ) - : - OSstream - ( -- *(new std::ostringstream()), -+ *(new std::ostringstream()), - "OStringStream.sinkFile", - format, - version - ) - {} - -+ //- Construct as copy -+ OStringStream(const OStringStream& oss) -+ : -+ OSstream -+ ( -+ *( -+ new std::ostringstream -+ ( -+ dynamic_cast<const std::ostringstream&> -+ ( -+ oss.stream() -+ ).str() -+ ) -+ ), -+ oss.name(), -+ oss.format(), -+ oss.version() -+ ) -+ {} -+ - - // Destructor - - ~OStringStream() - { - delete &dynamic_cast<std::ostringstream&>(stream()); - } -Index: OpenFOAM/fields/pointPatchFields/pointPatchField/pointPatchFieldFunctions.H -=================================================================== ---- src/OpenFOAM/fields/pointPatchFields/pointPatchField/pointPatchFieldFunctions.H (Revision 30) -+++ src/OpenFOAM/fields/pointPatchFields/pointPatchField/pointPatchFieldFunctions.H (Revision 439) -@@ -214,32 +214,28 @@ - #undef BINARY_TYPE_OPERATOR_FT - - - #define PRODUCT_OPERATOR(product, op, opFunc) \ - \ - template \ - < \ -- template<class> class PatchField, \ -- class pointPatch, \ - class Type1, \ - class Type2 \ - > \ - inline void opFunc \ - ( \ - pointPatchField \ - <typename product<Type1, Type2>::type>& f, \ - const pointPatchField<Type1>& f1, \ - const pointPatchField<Type2>& f2 \ - ) \ - {} \ - \ - template \ - < \ -- template<class> class PatchField, \ -- class pointPatch, \ - class Type, \ - class Form, \ - class Cmpt, \ - int nCmpt \ - > \ - inline void opFunc \ - ( \ -@@ -248,16 +244,14 @@ - const pointPatchField<Type>& f1, \ - const VectorSpace<Form,Cmpt,nCmpt>& vs \ - ) \ - {} \ - \ - template \ - < \ -- template<class> class PatchField, \ -- class pointPatch, \ - class Form, \ - class Cmpt, \ - int nCmpt, \ - class Type \ - > \ - inline void opFunc \ - ( \ -@@ -272,112 +266,99 @@ - PRODUCT_OPERATOR(crossProduct, ^, cross) - PRODUCT_OPERATOR(innerProduct, &, dot) - PRODUCT_OPERATOR(scalarProduct, &&, dotdot) - - #undef PRODUCT_OPERATOR - - --template<template<class> class PatchField, class pointPatch> --void hdual -+inline void hdual - ( - pointPatchField<vector>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void hdual -+inline void hdual - ( - pointPatchField<tensor>&, - const pointPatchField<vector>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void diag -+inline void diag - ( - pointPatchField<vector>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void tr -+inline void tr - ( - pointPatchField<scalar>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void dev -+inline void dev - ( - pointPatchField<tensor>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void dev2 -+inline void dev2 - ( - pointPatchField<tensor>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void det -+inline void det - ( - pointPatchField<scalar>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void inv -+inline void inv - ( - pointPatchField<tensor>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void symm -+inline void symm - ( - pointPatchField<tensor>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void twoSymm -+inline void twoSymm - ( - pointPatchField<tensor>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void skew -+inline void skew - ( - pointPatchField<tensor>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void eigenValues -+inline void eigenValues - ( - pointPatchField<vector>&, - const pointPatchField<tensor>& - ) - {} - --template<template<class> class PatchField, class pointPatch> --void eigenVectors -+inline void eigenVectors - ( - pointPatchField<tensor>&, - const pointPatchField<tensor>& - ) - {} - - -Index: OpenFOAM/fields/Fields/symmTensorField/symmTensorField.C -=================================================================== ---- src/OpenFOAM/fields/Fields/symmTensorField/symmTensorField.C (Revision 30) -+++ src/OpenFOAM/fields/Fields/symmTensorField/symmTensorField.C (Revision 439) -@@ -131,16 +131,15 @@ - - template<> - tmp<Field<symmTensor> > transformFieldMask<symmTensor> - ( - const tmp<tensorField>& ttf - ) - { -- tmp<Field<symmTensor> > ret = -- transformFieldMask<symmTensor>(ttf()); -+ tmp<Field<symmTensor> > ret = transformFieldMask<symmTensor>(ttf()); - ttf.clear(); - return ret; - } - - - template<> - tmp<Field<symmTensor> > transformFieldMask<symmTensor> -@@ -153,18 +152,15 @@ - - template<> - tmp<Field<symmTensor> > transformFieldMask<symmTensor> - ( - const tmp<symmTensorField>& tstf - ) - { -- tmp<Field<symmTensor> > ret = -- transformFieldMask<symmTensor>(tstf()); -- tstf.clear(); -- return ret; -+ return tstf; - } - - - // * * * * * * * * * * * * * * * global operators * * * * * * * * * * * * * // - - UNARY_OPERATOR(vector, symmTensor, *, hdual) - -Index: OpenFOAM/primitives/Tensor/TensorI.H -=================================================================== ---- src/OpenFOAM/primitives/Tensor/TensorI.H (Revision 30) -+++ src/OpenFOAM/primitives/Tensor/TensorI.H (Revision 439) -@@ -358,14 +358,23 @@ - v1.x()*v2.x(), v1.x()*v2.y(), v1.x()*v2.z(), - v1.y()*v2.x(), v1.y()*v2.y(), v1.y()*v2.z(), - v1.z()*v2.x(), v1.z()*v2.y(), v1.z()*v2.z() - ); - } - - -+//- Division of a vector by a tensor, i.e. dot-product with the tensor inverse -+template <class Cmpt> -+inline typename innerProduct<Vector<Cmpt>, Tensor<Cmpt> >::type -+operator/(const Vector<Cmpt>& v, const Tensor<Cmpt>& t) -+{ -+ return inv(t) & v; -+} -+ -+ - // * * * * * * * * * * * * * * * Global Functions * * * * * * * * * * * * * // - - //- Return the trace of a tensor - template <class Cmpt> - inline Cmpt tr(const Tensor<Cmpt>& t) - { - return t.xx() + t.yy() + t.zz(); -@@ -790,46 +799,30 @@ - //- Double-dot-product between a spherical tensor and a tensor - template <class Cmpt> - inline Cmpt - operator&&(const SymmTensor<Cmpt>& st1, const Tensor<Cmpt>& t2) - { - return - ( -- st1.xx()*t2.xx() + st1.xy()*t2.yx() + st1.xz()*t2.zx() + -- st1.xx()*t2.xy() + st1.xy()*t2.yy() + st1.xz()*t2.zy() + -- st1.xx()*t2.xz() + st1.xy()*t2.yz() + st1.xz()*t2.zz() + -- -- st1.xy()*t2.xx() + st1.yy()*t2.yx() + st1.yz()*t2.zx() + -- st1.xy()*t2.xy() + st1.yy()*t2.yy() + st1.yz()*t2.zy() + -- st1.xy()*t2.xz() + st1.yy()*t2.yz() + st1.yz()*t2.zz() + -- -- st1.xz()*t2.xx() + st1.yz()*t2.yx() + st1.zz()*t2.zx() + -- st1.xz()*t2.xy() + st1.yz()*t2.yy() + st1.zz()*t2.zy() + -- st1.xz()*t2.xz() + st1.yz()*t2.yz() + st1.zz()*t2.zz() -+ st1.xx()*t2.xx() + st1.xy()*t2.xy() + st1.xz()*t2.xz() + -+ st1.xy()*t2.yx() + st1.yy()*t2.yy() + st1.yz()*t2.yz() + -+ st1.xz()*t2.zx() + st1.yz()*t2.zy() + st1.zz()*t2.zz() - ); - } - - - //- Double-dot-product between a tensor and a spherical tensor - template <class Cmpt> - inline Cmpt - operator&&(const Tensor<Cmpt>& t1, const SymmTensor<Cmpt>& st2) - { - return - ( - t1.xx()*st2.xx() + t1.xy()*st2.xy() + t1.xz()*st2.xz() + -- t1.xx()*st2.xy() + t1.xy()*st2.yy() + t1.xz()*st2.yz() + -- t1.xx()*st2.xz() + t1.xy()*st2.yz() + t1.xz()*st2.zz() + -- -- t1.yx()*st2.xx() + t1.yy()*st2.xy() + t1.yz()*st2.xz() + - t1.yx()*st2.xy() + t1.yy()*st2.yy() + t1.yz()*st2.yz() + -- t1.yx()*st2.xz() + t1.yy()*st2.yz() + t1.yz()*st2.zz() + -- -- t1.zx()*st2.xx() + t1.zy()*st2.xy() + t1.zz()*st2.xz() + -- t1.zx()*st2.xy() + t1.zy()*st2.yy() + t1.zz()*st2.yz() + - t1.zx()*st2.xz() + t1.zy()*st2.yz() + t1.zz()*st2.zz() - ); - } - - - template<class Cmpt> - class typeOfSum<SymmTensor<Cmpt>, Tensor<Cmpt> > - -Index: finiteVolume/fvMatrices/fvMatrix/fvMatrixSolve.C -=================================================================== ---- src/finiteVolume/fvMatrices/fvMatrix/fvMatrixSolve.C (Revision 30) -+++ src/finiteVolume/fvMatrices/fvMatrix/fvMatrixSolve.C (Revision 439) -@@ -20,23 +20,18 @@ - - You should have received a copy of the GNU General Public License - along with OpenFOAM; if not, write to the Free Software Foundation, - Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA - - \*---------------------------------------------------------------------------*/ - --// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -- --namespace Foam --{ -- - // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // - - template<class Type> --void fvMatrix<Type>::setComponentReference -+void Foam::fvMatrix<Type>::setComponentReference - ( - const label patchi, - const label facei, - const direction cmpt, - const scalar value - ) - { -@@ -52,15 +47,18 @@ - *value; - } - } - } - - - template<class Type> --lduMatrix::solverPerformance fvMatrix<Type>::solve(Istream& solverControls) -+Foam::lduMatrix::solverPerformance Foam::fvMatrix<Type>::solve -+( -+ Istream& solverControls -+) - { - if (debug) - { - Info<< "fvMatrix<Type>::solve(Istream& solverControls) : " - "solving fvMatrix<Type>" - << endl; - } -@@ -70,15 +68,19 @@ - "fvMatrix<Type>::solve", - psi_.name() - ); - - scalarField saveDiag = diag(); - - Field<Type> source = source_; -- addBoundarySource(source, false); -+ -+ // At this point include the boundary source from the coupled boundaries. -+ // This is corrected for the implict part by updateMatrixInterfaces within -+ // the component loop. -+ addBoundarySource(source); - - typename Type::labelType validComponents - ( - pow - ( - psi_.mesh().directions(), - pTraits<typename powProduct<Vector<label>, Type::rank>::type>::zero -@@ -105,14 +107,35 @@ - ( - internalCoeffs_.component(cmpt) - ); - - lduInterfaceFieldPtrsList interfaces = - psi_.boundaryField().interfaces(); - -+ // Use the initMatrixInterfaces and updateMatrixInterfaces to correct -+ // bouCoeffsCmpt for the explicit part of the coupled boundary -+ // conditions -+ initMatrixInterfaces -+ ( -+ bouCoeffsCmpt, -+ interfaces, -+ psiCmpt, -+ sourceCmpt, -+ cmpt -+ ); -+ -+ updateMatrixInterfaces -+ ( -+ bouCoeffsCmpt, -+ interfaces, -+ psiCmpt, -+ sourceCmpt, -+ cmpt -+ ); -+ - lduMatrix::solverPerformance solverPerf; - - // Solver call - solverPerf = lduMatrix::solver::New - ( - psi_.name() + pTraits<Type>::componentNames[cmpt], - *this, -@@ -140,35 +163,36 @@ - psi_.correctBoundaryConditions(); - - return solverPerfVec; - } - - - template<class Type> --autoPtr<typename fvMatrix<Type>::fvSolver> fvMatrix<Type>::solver() -+Foam::autoPtr<typename Foam::fvMatrix<Type>::fvSolver> -+Foam::fvMatrix<Type>::solver() - { - return solver(psi_.mesh().solver(psi_.name())); - } - - template<class Type> --lduMatrix::solverPerformance fvMatrix<Type>::fvSolver::solve() -+Foam::lduMatrix::solverPerformance Foam::fvMatrix<Type>::fvSolver::solve() - { - return solve(psi_.mesh().solver(psi_.name())); - } - - - template<class Type> --lduMatrix::solverPerformance fvMatrix<Type>::solve() -+Foam::lduMatrix::solverPerformance Foam::fvMatrix<Type>::solve() - { - return solve(psi_.mesh().solver(psi_.name())); - } - - - template<class Type> --tmp<Field<Type> > fvMatrix<Type>::residual() const -+Foam::tmp<Foam::Field<Type> > Foam::fvMatrix<Type>::residual() const - { - tmp<Field<Type> > tres(source_); - Field<Type>& res = tres(); - - addBoundarySource(res); - - // Loop over field components -@@ -198,12 +222,8 @@ - ); - } - - return tres; - } - - --// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -- --} // End namespace Foam -- - // ************************************************************************* // -Index: finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.C -=================================================================== ---- src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.C (Revision 30) -+++ src/finiteVolume/fields/fvPatchFields/derived/timeVaryingMappedFixedValue/timeVaryingMappedFixedValueFvPatchField.C (Revision 439) -@@ -181,14 +181,15 @@ - ) - : - fixedValueFvPatchField<Type>(ptf, iF), - setAverage_(ptf.setAverage_), - referenceCS_(ptf.referenceCS_), - nearestVertex_(ptf.nearestVertex_), - nearestVertexWeight_(ptf.nearestVertexWeight_), -+ fieldName_(ptf.fieldName_), - sampleTimes_(ptf.sampleTimes_), - startSampleTime_(ptf.startSampleTime_), - startSampledValues_(ptf.startSampledValues_), - startAverage_(ptf.startAverage_), - endSampleTime_(ptf.endSampleTime_), - endSampledValues_(ptf.endSampledValues_), - endAverage_(ptf.endAverage_) -Index: finiteVolume/finiteVolume/ddtSchemes/backwardDdtScheme/backwardDdtScheme.C -=================================================================== ---- src/finiteVolume/finiteVolume/ddtSchemes/backwardDdtScheme/backwardDdtScheme.C (Revision 30) -+++ src/finiteVolume/finiteVolume/ddtSchemes/backwardDdtScheme/backwardDdtScheme.C (Revision 439) -@@ -323,15 +323,15 @@ - *vf.oldTime().internalField()*mesh().V0() - - coefft00*rho.oldTime().oldTime().internalField() - *vf.oldTime().oldTime().internalField()*mesh().V00() - )/mesh().V() - ), - rDeltaT.value()* - ( -- coefft*vf.boundaryField() - -+ coefft*rho.boundaryField()*vf.boundaryField() - - ( - coefft0*rho.oldTime().boundaryField() - *vf.oldTime().boundaryField() - - coefft00*rho.oldTime().oldTime().boundaryField() - *vf.oldTime().oldTime().boundaryField() - ) - ) -Index: finiteVolume/finiteVolume/gradSchemes/leastSquaresGrad/leastSquaresVectors.C -=================================================================== ---- src/finiteVolume/finiteVolume/gradSchemes/leastSquaresGrad/leastSquaresVectors.C (Revision 30) -+++ src/finiteVolume/finiteVolume/gradSchemes/leastSquaresGrad/leastSquaresVectors.C (Revision 439) -@@ -150,15 +150,15 @@ - if (p.coupled()) - { - forAll(pd, patchFacei) - { - const vector& d = pd[patchFacei]; - - dd[faceCells[patchFacei]] += -- (pw[patchFacei]*pMagSf[patchFacei]/magSqr(d))*sqr(d); -+ ((1 - pw[patchFacei])*pMagSf[patchFacei]/magSqr(d))*sqr(d); - } - } - else - { - forAll(pd, patchFacei) - { - const vector& d = pd[patchFacei]; - -Index: turbulenceModels/compressible/kOmegaSST/kOmegaSST.C -=================================================================== ---- src/turbulenceModels/compressible/kOmegaSST/kOmegaSST.C (Revision 30) -+++ src/turbulenceModels/compressible/kOmegaSST/kOmegaSST.C (Revision 439) -@@ -237,15 +237,15 @@ - { - y_.correct(); - divU += fvc::div(mesh_.phi()); - } - - tmp<volTensorField> tgradU = fvc::grad(U_); - volScalarField S2 = magSqr(symm(tgradU())); -- volScalarField GbyMu = 2*mut_*(tgradU() && dev(symm(tgradU()))); -+ volScalarField GbyMu = 2*(tgradU() && dev(symm(tgradU()))); - volScalarField G = mut_*GbyMu; - tgradU.clear(); - - # include "kOmegaWallFunctionsI.H" - - volScalarField CDkOmega = - (2*alphaOmega2)*(fvc::grad(k_) & fvc::grad(omega_))/omega_; -@@ -280,15 +280,15 @@ - // Turbulent kinetic energy equation - tmp<fvScalarMatrix> kEqn - ( - fvm::ddt(rho_, k_) - + fvm::div(phi_, k_) - - fvm::laplacian(DkEff(F1), k_) - == -- min(G, c1*betaStar*k_*omega_) -+ min(G, (c1*betaStar)*rho_*k_*omega_) - - fvm::SuSp(2.0/3.0*rho_*divU, k_) - - fvm::Sp(rho_*betaStar*omega_, k_) - ); - - kEqn().relax(); - solve(kEqn); - bound(k_, k0_); - diff --git a/sci-libs/openfoam-src/files/openfoam-src-compile-1.4.1_p20080131.patch b/sci-libs/openfoam-src/files/openfoam-src-compile-1.4.1_p20080131.patch deleted file mode 100644 index 708c0deca..000000000 --- a/sci-libs/openfoam-src/files/openfoam-src-compile-1.4.1_p20080131.patch +++ /dev/null @@ -1,231 +0,0 @@ -diff -ur OpenFOAM-1.4.1-src/src/Allwmake OpenFOAM-1.4.1/src/Allwmake ---- OpenFOAM-1.4.1-src/src/Allwmake 2007-07-27 17:54:28.000000000 +0200 -+++ OpenFOAM-1.4.1/src/Allwmake 2007-10-18 21:04:12.000000000 +0200 -@@ -3,103 +3,103 @@ - - (cd $FOAM_SRC/OpenFOAM ; wmakeLnInclude . ) - --wmake libso zlib-1.2.1 -- --if [ "$WM_MPLIB" = "OPENMPI" -a ! -r $OPENMPI_ARCH_PATH/lib/libmpi.a -a ! -r $OPENMPI_ARCH_PATH/lib/libmpi.so ] --then -- -- cd $OPENMPI_HOME -- -- gmake distclean -- rm -rf $OPENMPI_ARCH_PATH -- -- ./configure \ -- --prefix=$OPENMPI_ARCH_PATH \ -- --disable-mpirun-prefix-by-default \ -- --disable-orterun-prefix-by-default \ -- --enable-shared --disable-static \ -- --disable-mpi-f77 --disable-mpi-f90 --disable-mpi-cxx \ -- --disable-mpi-profile -- -- gmake -- gmake install -- gmake distclean -- -- cd $FOAM_SRC --fi -- --if [ "$WM_MPLIB" = "LAM" -a ! -r $LAM_ARCH_PATH/lib/libmpi.a -a ! -r $LAM_ARCH_PATH/lib/libmpi.so ] --then -- -- cd $LAMHOME -- -- gmake distclean -- rm -rf $LAM_ARCH_PATH -- -- ./configure \ -- --prefix=$LAM_ARCH_PATH \ -- --enable-shared \ -- --disable-static \ -- --without-romio \ -- --without-mpi2cpp \ -- --without-profiling \ -- --without-fc -- -- gmake -- gmake install -- gmake distclean -- -- cd $FOAM_SRC --fi -- --if [ "$WM_MPLIB" = "MPICH" -a ! -r $MPICH_ARCH_PATH/lib/libmpich.a -a ! -r $MPICH_ARCH_PATH/lib/libmpich.so ] --then -- -- cd $MPICH_PATH -- -- make distclean -- rm -rf $MPICH_ARCH_PATH -- rm util/machines/machines.* -- -- ./configure \ -- --without-mpe \ -- --disable-f77 \ -- --disable-f90 \ -- --disable-f90modules \ -- --disable-c++ \ -- --disable-mpedbg \ -- --disable-devdebug \ -- --disable-debug \ -- --enable-sharedlib=$MPICH_ARCH_PATH/lib \ -- --with-device=ch_p4 \ -- -prefix=$MPICH_ARCH_PATH -- make -- make install -- make distclean -- -- if [ -r $MPICH_ARCH_PATH ] -- then -- cd $MPICH_ARCH_PATH/bin -- for file in * -- do -- sed s%$MPICH_ARCH_PATH%'$MPICH_ARCH_PATH'%g $file > temp.$$ -- mv temp.$$ $file -- chmod ugo+rx $file -- done -- -- cd $MPICH_ARCH_PATH/lib -- -- if [ -r libmpich.so.1.0 ] -- then -- rm *.so -- ln -s libmpich.so.1.0 libmpich.so -- fi -- -- cd $MPICH_ARCH_PATH -- fi -- -- cd $FOAM_SRC --fi -+# wmake libso zlib-1.2.1 -+# -+# if [ "$WM_MPLIB" = "OPENMPI" -a ! -r $OPENMPI_ARCH_PATH/lib/libmpi.a -a ! -r $OPENMPI_ARCH_PATH/lib/libmpi.so ] -+# then -+# -+# cd $OPENMPI_HOME -+# -+# gmake distclean -+# rm -rf $OPENMPI_ARCH_PATH -+# -+# ./configure \ -+# --prefix=$OPENMPI_ARCH_PATH \ -+# --disable-mpirun-prefix-by-default \ -+# --disable-orterun-prefix-by-default \ -+# --enable-shared --disable-static \ -+# --disable-mpi-f77 --disable-mpi-f90 --disable-mpi-cxx \ -+# --disable-mpi-profile -+# -+# gmake -+# gmake install -+# gmake distclean -+# -+# cd $FOAM_SRC -+# fi -+# -+# if [ "$WM_MPLIB" = "LAM" -a ! -r $LAM_ARCH_PATH/lib/libmpi.a -a ! -r $LAM_ARCH_PATH/lib/libmpi.so ] -+# then -+# -+# cd $LAMHOME -+# -+# gmake distclean -+# rm -rf $LAM_ARCH_PATH -+# -+# ./configure \ -+# --prefix=$LAM_ARCH_PATH \ -+# --enable-shared \ -+# --disable-static \ -+# --without-romio \ -+# --without-mpi2cpp \ -+# --without-profiling \ -+# --without-fc -+# -+# gmake -+# gmake install -+# gmake distclean -+# -+# cd $FOAM_SRC -+# fi -+# -+# if [ "$WM_MPLIB" = "MPICH" -a ! -r $MPICH_ARCH_PATH/lib/libmpich.a -a ! -r $MPICH_ARCH_PATH/lib/libmpich.so ] -+# then -+# -+# cd $MPICH_PATH -+# -+# make distclean -+# rm -rf $MPICH_ARCH_PATH -+# rm util/machines/machines.* -+# -+# ./configure \ -+# --without-mpe \ -+# --disable-f77 \ -+# --disable-f90 \ -+# --disable-f90modules \ -+# --disable-c++ \ -+# --disable-mpedbg \ -+# --disable-devdebug \ -+# --disable-debug \ -+# --enable-sharedlib=$MPICH_ARCH_PATH/lib \ -+# --with-device=ch_p4 \ -+# -prefix=$MPICH_ARCH_PATH -+# make -+# make install -+# make distclean -+# -+# if [ -r $MPICH_ARCH_PATH ] -+# then -+# cd $MPICH_ARCH_PATH/bin -+# for file in * -+# do -+# sed s%$MPICH_ARCH_PATH%'$MPICH_ARCH_PATH'%g $file > temp.$$ -+# mv temp.$$ $file -+# chmod ugo+rx $file -+# done -+# -+# cd $MPICH_ARCH_PATH/lib -+# -+# if [ -r libmpich.so.1.0 ] -+# then -+# rm *.so -+# ln -s libmpich.so.1.0 libmpich.so -+# fi -+# -+# cd $MPICH_ARCH_PATH -+# fi -+# -+# cd $FOAM_SRC -+# fi - - (cd Pstream ; ./Allwmake) - wmake libso OpenFOAM -diff -ur OpenFOAM-1.4.1-src/src/Allwmake OpenFOAM-1.4.1/src/Allwmake ---- OpenFOAM-1.4.1-src/src/Allwmake 2007-07-27 17:54:28.000000000 +0200 -+++ OpenFOAM-1.4.1/src/Allwmake 2007-10-18 21:04:12.000000000 +0200 -@@ -141,13 +141,13 @@ - - (cd malloc ; ./Allwmake) - --if [ ! -r $MICO_ARCH_PATH/lib/libmico${MICO_VERSION}.a ] --then -- cd $MICO_PATH -- gmake distclean -- ./configure --prefix=$MICO_ARCH_PATH --disable-shared --without-x -- gmake -- gmake install -- gmake distclean -- cd .. --fi -+# if [ ! -r $MICO_ARCH_PATH/lib/libmico${MICO_VERSION}.a ] -+# then -+# cd $MICO_PATH -+# gmake distclean -+# ./configure --prefix=$MICO_ARCH_PATH --disable-shared --without-x -+# gmake -+# gmake install -+# gmake distclean -+# cd .. -+# fi diff --git a/sci-libs/openfoam-src/openfoam-src-1.4.1_p20080131.ebuild b/sci-libs/openfoam-src/openfoam-src-1.4.1_p20080131.ebuild index 058539d37..b759909df 100644 --- a/sci-libs/openfoam-src/openfoam-src-1.4.1_p20080131.ebuild +++ b/sci-libs/openfoam-src/openfoam-src-1.4.1_p20080131.ebuild @@ -10,7 +10,8 @@ MY_P="${MY_PN}-${MY_PV}" DESCRIPTION="OpenFOAM - Kernel Sources" HOMEPAGE="http://www.opencfd.co.uk/openfoam/" -SRC_URI="mirror://sourceforge/foam/${MY_P}.General.gtgz" +SRC_URI="mirror://sourceforge/foam/${MY_P}.General.gtgz + http://dev.gentooexperimental.org/~jokey/sunrise-dist/${P}-patches-0.1.tar.bz2" LICENSE="GPL-2" SLOT="0" @@ -25,10 +26,11 @@ S=${WORKDIR}/${MY_P} src_unpack() { ln -s "${DISTDIR}"/${MY_P}.General.gtgz ${MY_P}.General.tgz unpack ./${MY_P}.General.tgz + unpack "${DISTDIR}"/${P}-patches-0.1.tar.bz2 cd "${S}" - epatch "${FILESDIR}"/${P}.patch - epatch "${FILESDIR}"/${PN}-compile-${PV}.patch + epatch "${WORKDIR}"/patch/${P}.patch + epatch "${WORKDIR}"/patch/${PN}-compile-${PV}.patch } src_install() { |