diff --git a/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C b/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C index 899159b2a29ba4005f6fdd740260f1fee794674b..f1d61f14a7e0552c1bde7f3c5caf87c594cde27a 100644 --- a/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C +++ b/applications/utilities/mesh/advanced/collapseEdges/collapseEdges.C @@ -28,27 +28,22 @@ Description - merge two edges if they are in line. Maximum angle provided as argument. - remove unused points. - Cannot remove cells. Can remove faces and points but does not check + Optionally removes cells. Can remove faces and points but does not check for nonsense resulting topology. When collapsing an edge with one point on the boundary it will leave the boundary point intact. When both points inside it chooses random. When - both points on boundary random again. Note: it should in fact use features - where if one point is on a feature it collapses to that one. Alas we don't - have features on a polyMesh. + both points on boundary random again. \*---------------------------------------------------------------------------*/ #include "argList.H" #include "Time.H" #include "polyTopoChange.H" -#include "polyTopoChanger.H" -#include "polyMesh.H" #include "fvMesh.H" #include "mapPolyMesh.H" #include "mathematicalConstants.H" #include "PackedBoolList.H" -#include "SortableList.H" #include "unitConversion.H" #include "globalMeshData.H" #include "globalIndex.H" @@ -56,32 +51,10 @@ Description #include "pointEdgeCollapse.H" #include "motionSmoother.H" -#include "OFstream.H" -#include "meshTools.H" - using namespace Foam; // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -label findIndex -( - const labelList& elems, - const label start, - const label size, - const label val -) -{ - for (label i = start; i < size; i++) - { - if (elems[i] == val) - { - return i; - } - } - return -1; -} - - void filterFace ( const label faceI, @@ -121,7 +94,7 @@ void filterFace } else { - if (findIndex(f, 0, newFp, collapsePoint) == -1) + if (findIndex(SubList<label>(f, newFp), collapsePoint) == -1) { f[newFp++] = collapsePoint; } @@ -147,7 +120,7 @@ void filterFace label pointI = f[fp]; // Search for previous occurrence. - label index = findIndex(f, 0, fp, pointI); + label index = findIndex(SubList<label>(f, fp), pointI); if (index == fp1) { @@ -206,19 +179,50 @@ bool setRefinement boolList removedPoints(mesh.nPoints(), false); - // Create strings of edges + // Create strings of edges. + // Map from collapseIndex(=global master point) to set of points Map<DynamicList<label> > collapseStrings; - - forAll(allPointInfo, pointI) { - const label collapseIndex = allPointInfo[pointI].collapseIndex(); + // 1. Count elements per collapseIndex + Map<label> nPerIndex(mesh.nPoints()/10); + forAll(allPointInfo, pointI) + { + const label collapseIndex = allPointInfo[pointI].collapseIndex(); - if (collapseIndex != -1 && collapseIndex != -2) + if (collapseIndex != -1 && collapseIndex != -2) + { + Map<label>::iterator fnd = nPerIndex.find(collapseIndex); + if (fnd != nPerIndex.end()) + { + fnd()++; + } + else + { + nPerIndex.insert(collapseIndex, 1); + } + } + } + + // 2. Size + collapseStrings.resize(2*nPerIndex.size()); + forAllConstIter(Map<label>, nPerIndex, iter) { - collapseStrings(collapseIndex).append(pointI); + collapseStrings.insert(iter.key(), DynamicList<label>(iter())); + } + + // 3. Fill + forAll(allPointInfo, pointI) + { + const label collapseIndex = allPointInfo[pointI].collapseIndex(); + + if (collapseIndex != -1 && collapseIndex != -2) + { + collapseStrings[collapseIndex].append(pointI); + } } } + bool meshChanged = false; // Current faces (is also collapseStatus: f.size() < 3) @@ -293,7 +297,7 @@ bool setRefinement if (nFaces < 4) { - Info<< "Cell:" << cellI + Pout<< "Cell:" << cellI << " uses faces:" << cFaces << " of which too many are marked for removal:" << endl @@ -302,10 +306,10 @@ bool setRefinement { if (newFaces[cFaces[j]].size() < 3) { - Info<< ' '<< cFaces[j]; + Pout<< ' '<< cFaces[j]; } } - Info<< endl; + Pout<< endl; cellRemoved[cellI] = true; @@ -463,9 +467,6 @@ bool setRefinement } } - // Print regions: -// printRegions(); - return meshChanged; } @@ -507,99 +508,6 @@ labelList getSortedEdges } -// Merges edges which are in straight line. I.e. edge split by point. -//label mergeEdges -//( -// const polyMesh& mesh, -// const scalar maxCos, -// List<pointEdgeCollapse>& allPointInfo -//) -//{ -// const pointField& points = mesh.points(); -// const edgeList& edges = mesh.edges(); -// const labelListList& pointEdges = mesh.pointEdges(); -// const labelList& region = collapser.pointRegion(); -// const labelList& master = collapser.pointRegionMaster(); -// -// label nCollapsed = 0; -// -// forAll(pointEdges, pointI) -// { -// const labelList& pEdges = pointEdges[pointI]; -// -// if (pEdges.size() == 2) -// { -// const edge& leftE = edges[pEdges[0]]; -// const edge& rightE = edges[pEdges[1]]; -// -// // Get the two vertices on both sides of the point -// label leftV = leftE.otherVertex(pointI); -// label rightV = rightE.otherVertex(pointI); -// -// // Collapse only if none of the points part of merge network -// // or all of networks with different masters. -// label midMaster = -1; -// if (region[pointI] != -1) -// { -// midMaster = master[region[pointI]]; -// } -// -// label leftMaster = -2; -// if (region[leftV] != -1) -// { -// leftMaster = master[region[leftV]]; -// } -// -// label rightMaster = -3; -// if (region[rightV] != -1) -// { -// rightMaster = master[region[rightV]]; -// } -// -// if -// ( -// midMaster != leftMaster -// && midMaster != rightMaster -// && leftMaster != rightMaster -// ) -// { -// // Check if the two edge are in line -// vector leftVec = points[pointI] - points[leftV]; -// leftVec /= mag(leftVec) + VSMALL; -// -// vector rightVec = points[rightV] - points[pointI]; -// rightVec /= mag(rightVec) + VSMALL; -// -// if ((leftVec & rightVec) > maxCos) -// { -// // Collapse one (left) side of the edge. Make left vertex -// // the master. -// //if (collapser.unaffectedEdge(pEdges[0])) -// const edge& e = mesh.edges()[pEdges[0]]; -// -// if -// ( -// allPointInfo[e[0]].collapseIndex() < 0 -// && allPointInfo[e[1]].collapseIndex() < 0 -// ) -// { -// //pointEdgeCollapse pec(mesh.points()[leftV], leftV); -// -// allPointInfo[e[0]] = pec; -// allPointInfo[e[1]] = pec; -// -// //collapser.collapseEdge(pEdges[0], leftV); -// nCollapsed++; -// } -// } -// } -// } -// } -// -// return nCollapsed; -//} - - // Return master point edge needs to be collapsed to (or -1) label edgeMaster ( @@ -673,112 +581,22 @@ label edgeMaster } -label collapseSmallEdges +// Create consistent set of collapses. +// collapseEdge : per edge: +// -1 : do not collapse +// 0 : collapse to start +// 1 : collapse to end +// Note: collapseEdge has to be parallel consistent (in orientation) +label syncCollapse ( const polyMesh& mesh, - const scalarList& freezeEdges, - const labelList& boundaryPoint, - const scalar minLen, + const globalIndex& globalStrings, + const labelList& collapseEdge, List<pointEdgeCollapse>& allPointInfo ) { - const pointField& points = mesh.points(); const edgeList& edges = mesh.edges(); - - // Store collapse direction in collapseEdge - // -1 -> Do not collapse - // 0 -> Collapse to start point - // 1 -> Collapse to end point - labelList collapseEdge(edges.size(), -1); - - forAll(edges, edgeI) - { - const edge& e = edges[edgeI]; - - if (e.mag(points) < minLen*freezeEdges[edgeI]) - { - collapseEdge[edgeI] = 0; - } - } - - // Check whether edge point order is reversed from mesh to coupledPatch -// const globalMeshData& globalData = mesh.globalData(); -// const mapDistribute& map = globalData.globalEdgeSlavesMap(); -// const labelList& coupledMeshEdges = globalData.coupledPatchMeshEdges(); -// const indirectPrimitivePatch& coupledPatch = globalData.coupledPatch(); -// const PackedBoolList& cppOrientation = globalData.globalEdgeOrientation(); -// PackedBoolList meshToPatchSameOrientation(coupledMeshEdges.size(), true); -// -// forAll(coupledMeshEdges, eI) -// { -// const label meshEdgeIndex = coupledMeshEdges[eI]; -// -// if (collapseEdge[meshEdgeIndex] != -1) -// { -// const edge& meshEdge = edges[meshEdgeIndex]; -// const edge& coupledPatchEdge = coupledPatch.edges()[eI]; -// -// if -// ( -// meshEdge[0] == coupledPatch.meshPoints()[coupledPatchEdge[1]] -// && meshEdge[1] == coupledPatch.meshPoints()[coupledPatchEdge[0]] -// ) -// { -// meshToPatchSameOrientation[eI] = false; -// } -// } -// } -// -// -// labelList cppEdgeData(coupledMeshEdges.size(), -1); -// -// forAll(coupledMeshEdges, eI) -// { -// const label meshEdgeIndex = coupledMeshEdges[eI]; -// -// if (collapseEdge[meshEdgeIndex] != -1) -// { -// if (meshToPatchSameOrientation[eI] == cppOrientation[eI]) -// { -// cppEdgeData[eI] = 0; -// } -// else -// { -// cppEdgeData[eI] = 1; -// } -// } -// } -// -// -// // Synchronise cppEdgeData -// // Use minEqOp reduction, so that edge will only be collapsed on processor -// // boundary if both processors agree to collapse it -// globalData.syncData -// ( -// cppEdgeData, -// globalData.globalEdgeSlaves(), -// globalData.globalEdgeTransformedSlaves(), -// map, -// minEqOp<label>() -// ); -// -// -// forAll(coupledMeshEdges, eI) -// { -// const label meshEdgeIndex = coupledMeshEdges[eI]; -// -// if (collapseEdge[meshEdgeIndex] != -1) -// { -// if (meshToPatchSameOrientation[eI] == cppOrientation[eI]) -// { -// collapseEdge[meshEdgeIndex] = 0; -// } -// else -// { -// collapseEdge[meshEdgeIndex] = 1; -// } -// } -// } + const pointField& points = mesh.points(); label nCollapsed = 0; @@ -786,46 +604,43 @@ label collapseSmallEdges DynamicList<pointEdgeCollapse> initPointInfo(mesh.nPoints()); allPointInfo.resize(mesh.nPoints()); - globalIndex globalStrings(mesh.nPoints()); - - List<pointEdgeCollapse> allEdgeInfo(mesh.nEdges()); - forAll(allEdgeInfo, edgeI) - { - allEdgeInfo[edgeI] = pointEdgeCollapse(vector::zero, -1); - } + // Initialise edges to no collapse + List<pointEdgeCollapse> allEdgeInfo + ( + mesh.nEdges(), + pointEdgeCollapse(vector::zero, -1) + ); + // Mark selected edges for collapse forAll(edges, edgeI) { const edge& e = edges[edgeI]; if (collapseEdge[edgeI] != -1) { - const label master = - edgeMaster - ( - boundaryPoint, - collapseEdge[edgeI], - e - ); + label masterPointI = e[collapseEdge[edgeI]]; -// if (master != -1) - { - pointEdgeCollapse pec - ( - points[master], - globalStrings.toGlobal(master) - ); + const pointEdgeCollapse pec + ( + points[masterPointI], + globalStrings.toGlobal(masterPointI) + ); - allEdgeInfo[edgeI] = pec; + // Mark as collapsable but with nonsense master so it gets + // overwritten and starts an update wave + allEdgeInfo[edgeI] = pointEdgeCollapse + ( + points[masterPointI], + labelMax + ); - initPointInfo.append(pec); - initPoints.append(e.start()); + initPointInfo.append(pec); + initPoints.append(e.start()); - initPointInfo.append(pec); - initPoints.append(e.end()); + initPointInfo.append(pec); + initPoints.append(e.end()); - nCollapsed++; - } + nCollapsed++; } } @@ -843,229 +658,342 @@ label collapseSmallEdges } -// Faces which have edges just larger than collapse length but faces which -// are very small. This one tries to collapse them if it can be done with -// edge collapse. For faces where a face gets replace by two edges use -// collapseFaces -//label collapseHighAspectFaces -//( -// const polyMesh& mesh, -// const PackedBoolList& boundaryPoint, -// const Map<label>& processorPoints, -// const scalar areaFac, -// const scalar edgeRatio, -// edgeCollapser& collapser -//) -//{ -// const pointField& points = mesh.points(); -// const edgeList& edges = mesh.edges(); -// const faceList& faces = mesh.faces(); -// const labelListList& faceEdges = mesh.faceEdges(); -// -// scalarField magArea(mag(mesh.faceAreas())); -// -// label maxIndex = findMax(magArea); -// -// scalar minArea = areaFac * magArea[maxIndex]; -// -// Info<< "Max face area:" << magArea[maxIndex] << endl -// << "Collapse area factor:" << areaFac << endl -// << "Collapse area:" << minArea << endl; -// -// label nCollapsed = 0; -// -// forAll(faces, faceI) -// { -// if (magArea[faceI] < minArea) -// { -// const face& f = faces[faceI]; -// -// // Get the edges in face point order -// labelList fEdges(getSortedEdges(edges, f, faceEdges[faceI])); -// -// SortableList<scalar> lengths(fEdges.size()); -// forAll(fEdges, i) -// { -// lengths[i] = edges[fEdges[i]].mag(points); -// } -// lengths.sort(); -// -// -// label edgeI = -1; -// -// if (f.size() == 4) -// { -// // Compare second largest to smallest -// if (lengths[2] > edgeRatio*lengths[0]) -// { -// // Collapse smallest only. Triangle should be cleared -// // next time around. -// edgeI = fEdges[lengths.indices()[0]]; -// } -// } -// else if (f.size() == 3) -// { -// // Compare second largest to smallest -// if (lengths[1] > edgeRatio*lengths[0]) -// { -// edgeI = fEdges[lengths.indices()[0]]; -// } -// } -// -// -// if (edgeI != -1) -// { -// label master = edgeMaster -// ( -// boundaryPoint, -// processorPoints, -// false, -// edges[edgeI] -// ); -// -// if (master != -1)// && collapser.unaffectedEdge(edgeI)) -// { -// collapser.collapseEdge(edgeI, master); -// nCollapsed++; -// } -// } -// } -// } -// -// return nCollapsed; -//} +void syncCollapseEdge(const polyMesh& mesh, labelList& collapseEdge) +{ + // Check whether edge point order is reversed from mesh to coupledPatch + const globalMeshData& globalData = mesh.globalData(); + const mapDistribute& map = globalData.globalEdgeSlavesMap(); + const labelList& coupledMeshEdges = globalData.coupledPatchMeshEdges(); + const indirectPrimitivePatch& coupledPatch = globalData.coupledPatch(); + const PackedBoolList& cppOrientation = globalData.globalEdgeOrientation(); + PackedBoolList meshToPatchSameOrientation(coupledMeshEdges.size(), true); + + forAll(coupledMeshEdges, eI) + { + const label meshEdgeIndex = coupledMeshEdges[eI]; + + if (collapseEdge[meshEdgeIndex] != -1) + { + const edge& meshEdge = mesh.edges()[meshEdgeIndex]; + const edge& coupledPatchEdge = coupledPatch.edges()[eI]; + + if + ( + meshEdge[0] == coupledPatch.meshPoints()[coupledPatchEdge[1]] + && meshEdge[1] == coupledPatch.meshPoints()[coupledPatchEdge[0]] + ) + { + meshToPatchSameOrientation[eI] = false; + } + } + } + + + labelList cppEdgeData(map.constructSize()); + + forAll(coupledMeshEdges, eI) + { + const label meshEdgeIndex = coupledMeshEdges[eI]; + + cppEdgeData[eI] = collapseEdge[meshEdgeIndex]; + + if + ( + (collapseEdge[meshEdgeIndex] != -1) + && (meshToPatchSameOrientation[eI] != cppOrientation[eI]) + ) + { + cppEdgeData[eI] = 1-cppEdgeData[eI]; + } + } + + + // Synchronise cppEdgeData + // Use minEqOp reduction, so that edge will only be collapsed on processor + // boundary if both processors agree to collapse it + globalData.syncData + ( + cppEdgeData, + globalData.globalEdgeSlaves(), + globalData.globalEdgeTransformedSlaves(), + map, + minEqOp<label>() + ); -void set(const labelList& elems, const bool val, boolList& status) + forAll(coupledMeshEdges, eI) + { + const label meshEdgeIndex = coupledMeshEdges[eI]; + + collapseEdge[meshEdgeIndex] = cppEdgeData[eI]; + + if + ( + (cppEdgeData[eI] != -1) + && (meshToPatchSameOrientation[eI] != cppOrientation[eI]) + ) + { + collapseEdge[meshEdgeIndex] = 1-collapseEdge[meshEdgeIndex]; + } + } +} + + +// Mark (in collapseEdge) any edges to collapse +label collapseSmallEdges +( + const polyMesh& mesh, + const labelList& boundaryPoint, + const scalarField& minEdgeLen, + labelList& collapseEdge +) { - forAll(elems, i) + // Work out which edges to collapse + // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + + label nCollapsed = 0; + + forAll(mesh.edges(), edgeI) { - status[elems[i]] = val; + if (collapseEdge[edgeI] == -1) + { + const edge& e = mesh.edges()[edgeI]; + + if (e.mag(mesh.points()) < minEdgeLen[edgeI]) + { + label masterPointI = edgeMaster(boundaryPoint, false, e); + if (masterPointI == e[0]) + { + collapseEdge[edgeI] = 0; + } + else + { + collapseEdge[edgeI] = 1; + } + nCollapsed++; + } + } } + return nCollapsed; } -// Tries to simplify polygons to face of minSize (4=quad, 3=triangle) -//label simplifyFaces -//( -// const polyMesh& mesh, -// const PackedBoolList& boundaryPoint, -// const Map<label>& processorPoints, -// const label minSize, -// const scalar lenGap, -// edgeCollapser& collapser -//) -//{ -// const pointField& points = mesh.points(); -// const edgeList& edges = mesh.edges(); -// const faceList& faces = mesh.faces(); -// const cellList& cells = mesh.cells(); -// const labelListList& faceEdges = mesh.faceEdges(); -// const labelList& faceOwner = mesh.faceOwner(); -// const labelList& faceNeighbour = mesh.faceNeighbour(); -// const labelListList& pointCells = mesh.pointCells(); -// const labelListList& cellEdges = mesh.cellEdges(); -// -// label nCollapsed = 0; -// -// boolList protectedEdge(mesh.nEdges(), false); -// -// forAll(faces, faceI) -// { -// const face& f = faces[faceI]; -// -// if -// ( -// f.size() > minSize -// && cells[faceOwner[faceI]].size() >= 6 -// && ( -// mesh.isInternalFace(faceI) -// && cells[faceNeighbour[faceI]].size() >= 6 -// ) -// ) -// { -// // Get the edges in face point order -// labelList fEdges(getSortedEdges(edges, f, faceEdges[faceI])); -// -// SortableList<scalar> lengths(fEdges.size()); -// forAll(fEdges, i) -// { -// lengths[i] = edges[fEdges[i]].mag(points); -// } -// lengths.sort(); -// -// -// // Now find a gap in length between consecutive elements greater -// // than lenGap. -// -// label gapPos = -1; -// -// for (label i = f.size()-1-minSize; i >= 0; --i) -// { -// if (lengths[i+1] > lenGap*lengths[i]) -// { -// gapPos = i; -// -// break; -// } -// } -// -// if (gapPos != -1) -// { -// //for (label i = gapPos; i >= 0; --i) -// label i = 0; // Hack: collapse smallest edge only. -// { -// label edgeI = fEdges[lengths.indices()[i]]; -// -// if (!protectedEdge[edgeI]) -// { -// const edge& e = edges[edgeI]; -// -// label master -// = edgeMaster(boundaryPoint, processorPoints, false, e); -// -// if (master != -1) -// { -// collapser.collapseEdge(edgeI, master); -// -// // Protect all other edges on all cells using edge -// // points. -// -// const labelList& pCells0 = pointCells[e[0]]; -// -// forAll(pCells0, i) -// { -// set(cellEdges[pCells0[i]], true, protectedEdge); -// } -// const labelList& pCells1 = pointCells[e[1]]; -// -// forAll(pCells1, i) -// { -// set(cellEdges[pCells1[i]], true, protectedEdge); -// } -// -// nCollapsed++; -// } -// } -// } -// } -// } -// } -// -// return nCollapsed; -//} +// Mark (in collapseEdge) any edges to merge +label mergeEdges +( + const polyMesh& mesh, + const scalar maxCos, + const labelList& boundaryPoint, + const scalarField& minEdgeLen, + labelList& collapseEdge +) +{ + const pointField& points = mesh.points(); + const edgeList& edges = mesh.edges(); + const labelListList& pointEdges = mesh.pointEdges(); + + label nCollapsed = 0; + forAll(pointEdges, pointI) + { + const labelList& pEdges = pointEdges[pointI]; -labelHashSet checkMeshQuality(const polyMesh& mesh) + if (pEdges.size() == 2 && boundaryPoint[pointI] <= 0) + { + // Collapse only if none of the points part of merge network and + // none protected (minEdgeLen < 0) + label e0 = pEdges[0]; + label e1 = pEdges[1]; + + if + ( + collapseEdge[e0] == -1 + && minEdgeLen[e0] >= 0 + && collapseEdge[e1] == -1 + && minEdgeLen[e1] >= 0 + ) + { + const edge& leftE = edges[e0]; + const edge& rightE = edges[e1]; + + // Get the two vertices on both sides of the point + label leftV = leftE.otherVertex(pointI); + label rightV = rightE.otherVertex(pointI); + + // Check if the two edge are in line + vector leftVec = points[pointI] - points[leftV]; + leftVec /= mag(leftVec) + VSMALL; + + vector rightVec = points[rightV] - points[pointI]; + rightVec /= mag(rightVec) + VSMALL; + + if ((leftVec & rightVec) > maxCos) + { + // Collapse one (left) side of the edge. Make pointI + // the master. + collapseEdge[e0] = findIndex(leftE, pointI); + nCollapsed++; + } + } + } + } + return nCollapsed; +} + + +// Make consistent set of collapses that does not collapse any cells +label consistentCollapse +( + const bool allowCellCollapse, + const polyMesh& mesh, + const globalIndex& globalStrings, + labelList& collapseEdge, + List<pointEdgeCollapse>& allPointInfo +) +{ + // Make sure we don't collapse cells + // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + + while (true) + { + // Sync collapseEdge + syncCollapseEdge(mesh, collapseEdge); + + + // Get collapsed faces + + label nAdditionalCollapsed = 0; + + PackedBoolList isCollapsedFace(mesh.nFaces()); + forAll(mesh.faceEdges(), faceI) + { + const labelList& fEdges = mesh.faceEdges()[faceI]; + + // Count number of remaining edges + label nEdges = fEdges.size(); + forAll(fEdges, fEdgeI) + { + label edgeI = fEdges[fEdgeI]; + if (collapseEdge[edgeI] != -1) + { + nEdges--; + } + } + + if (nEdges < 3) + { + // Face is collapsed. + isCollapsedFace[faceI] = 1; + + if (nEdges == 1) + { + // Cannot collapse face down to single edge. + + //- Option 1: collapse remaining edge as well. However + // if this edge is on the coupled processor patch this + // logic clashes with that of syncCollapseEdge + // (do not collapse if any not collapse) + //forAll(fEdges, fEdgeI) + //{ + // label edgeI = fEdges[fEdgeI]; + // if (collapseEdge[edgeI] == -1) + // { + // collapseEdge[edgeI] = 0; + // nAdditionalCollapsed++; + // } + //} + + //- Option 2: uncollapse this face. + forAll(fEdges, fEdgeI) + { + label edgeI = fEdges[fEdgeI]; + if (collapseEdge[edgeI] != -1) + { + collapseEdge[edgeI] = -1; + nAdditionalCollapsed++; + } + } + } + } + } + + //Pout<< "nAdditionalCollapsed : " << nAdditionalCollapsed << endl; + + + label nUncollapsed = 0; + + if (!allowCellCollapse) + { + // Check collapsed cells + + forAll(mesh.cells(), cellI) + { + const cell& cFaces = mesh.cells()[cellI]; + label nFaces = cFaces.size(); + forAll(cFaces, i) + { + label faceI = cFaces[i]; + if (isCollapsedFace[faceI]) + { + nFaces--; + if (nFaces < 4) + { + // Unmark this face for collapse + const labelList& fEdges = mesh.faceEdges()[faceI]; + + forAll(fEdges, fEdgeI) + { + label edgeI = fEdges[fEdgeI]; + if (collapseEdge[edgeI] != -1) + { + collapseEdge[edgeI] = -1; + nUncollapsed++; + } + } + + // Uncollapsed this face. + isCollapsedFace[faceI] = 0; + nFaces++; + } + } + } + } + //Pout<< "** disallowing cells : nUncollapsed : " + // << nUncollapsed << endl; + } + + + if + ( + returnReduce(nUncollapsed+nAdditionalCollapsed, sumOp<label>()) + == 0 + ) + { + break; + } + } + + + // Create consistent set of collapses + // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + // Note: requires collapseEdge to be synchronised. (above loop makes sure + // of that) + + return syncCollapse(mesh, globalStrings, collapseEdge, allPointInfo); +} + + +// Check mesh and mark points on faces in error +// Returns boolList with points in error set +PackedBoolList checkMeshQuality(const polyMesh& mesh) { //mesh.checkMesh(true); - labelHashSet freezePoints; IOdictionary meshQualityDict ( IOobject ( - "meshQualityControls", + "meshQualityDict", mesh.time().system(), mesh.time(), IOobject::MUST_READ, @@ -1102,35 +1030,61 @@ labelHashSet checkMeshQuality(const polyMesh& mesh) Info<< nl << "Number of bad faces : " << nBadFaces << endl; + PackedBoolList isErrorPoint(mesh.nPoints()); forAllConstIter(labelHashSet, badFaces, iter) { const face& f = mesh.faces()[iter.key()]; forAll(f, pI) { - freezePoints.insert(f[pI]); + isErrorPoint[f[pI]] = 1; } } -// const edgeList& edges = mesh.edges(); -// -// label nFrozenEdges = 0; -// -// OFstream str("frozenEdges.obj"); -// -// label count = 0; -// forAll(edges, eI) -// { -// const edge& e = edges[eI]; -// -// if (freezePoints.found(e[0]) && freezePoints.found(e[1])) -// { -// freezeEdges[eI] = true; -// nFrozenEdges++; -// } -// } + syncTools::syncPointList + ( + mesh, + isErrorPoint, + orEqOp<unsigned int>(), + 0 + ); - return freezePoints; + return isErrorPoint; +} + + +// Check mesh with collapses (newMesh), updates minEdgeLen, nFrozenEdges +void checkMeshAndFreezeEdges +( + const polyMesh& newMesh, + const labelList& oldToNewMesh, + const polyMesh& oldMesh, + scalarField& minEdgeLen, + label& nFrozenEdges +) +{ + PackedBoolList isErrorPoint = checkMeshQuality(newMesh); + + forAll(oldMesh.edges(), edgeI) + { + const edge& e = oldMesh.edges()[edgeI]; + label newStart = oldToNewMesh[e[0]]; + label newEnd = oldToNewMesh[e[1]]; + + if + ( + (newStart >= 0 && isErrorPoint[newStart]) + || (newEnd >= 0 && isErrorPoint[newEnd]) + ) + { + // Gradual decrease? For now just hard disable + if (minEdgeLen[edgeI] > -GREAT/2) + { + minEdgeLen[edgeI] = -GREAT; + nFrozenEdges++; + } + } + } } @@ -1165,14 +1119,21 @@ labelList findBoundaryPoints(const polyMesh& mesh) { const polyPatch& patch = bMesh[patchI]; - if (isA<processorPolyPatch>(patch)) + if (isA<coupledPolyPatch>(patch)) { - const processorPolyPatch& pPatch = - refCast<const processorPolyPatch>(patch); + if (patchI == 0) + { + // We mark 'normal' boundary points with 0 so make sure this + // coupled patch is not 0. + FatalErrorIn("findBoundaryPoints(const polyMesh&)") + << "Your patches should have non-coupled ones before any" + << " coupled ones. Current patches " << bMesh.names() + << exit(FatalError); + } - forAll(pPatch, fI) + forAll(patch, fI) { - const face& f = pPatch[fI]; + const face& f = patch[fI]; forAll(f, fp) { @@ -1189,11 +1150,28 @@ labelList findBoundaryPoints(const polyMesh& mesh) // Main program: int main(int argc, char *argv[]) { + argList::addNote + ( + "Merges small and in-line edges.\n" + "Collapses faces and optionally cells to a point." + ); + # include "addOverwriteOption.H" argList::validArgs.append("edge length [m]"); argList::validArgs.append("merge angle (degrees)"); - argList::addOption("minLenFactor", "scalar", "edge length factor"); + argList::addBoolOption + ( + "allowCellCollapse", + "Allow collapsing of cells to a single point" + ); + argList::addBoolOption + ( + "checkMeshQuality", + "Only collapse if not exceeding given meshQualityDict limits" + ); + + # include "setRootCase.H" # include "createTime.H" @@ -1201,12 +1179,12 @@ int main(int argc, char *argv[]) # include "createPolyMesh.H" const word oldInstance = mesh.pointsInstance(); - scalar minLen = args.argRead<scalar>(1); - const scalar angle = args.argRead<scalar>(2); - const scalar minLenFactor - = args.optionLookupOrDefault<scalar>("minLenFactor", 0.5); + scalar minLen = args.argRead<scalar>(1); + const scalar angle = args.argRead<scalar>(2); + const bool allowCellCollapse = args.optionFound("allowCellCollapse"); const bool overwrite = args.optionFound("overwrite"); + const bool checkQuality = args.optionFound("checkMeshQuality"); scalar maxCos = Foam::cos(degToRad(angle)); @@ -1216,190 +1194,216 @@ int main(int argc, char *argv[]) << " degrees" << nl << endl; - Info<< "If an invalid mesh is generated then the edge length will be " << nl - << "multiplied by a factor of " << minLenFactor << " and collapsing " - << "will be reattempted" << nl << endl; - - bool meshChanged = false; - - checkMeshQuality(mesh); - - autoPtr<fvMesh> fvMeshPtr; - - scalarList freezeEdges(mesh.nEdges(), 1.0); - - do + if (allowCellCollapse) { - label nIterations = 0; - label nFrozenEdges = 0; - - fvMeshPtr.reset(new fvMesh(mesh)); - fvMesh& fvMeshRef = fvMeshPtr(); - - // Contains new point label for original points - labelList pointMap(identity(mesh.nPoints())); + Info<< "Allowing collapse of cells down to a point." << nl + << endl; + } + else + { + Info<< "Disallowing collapse of cells down to a point." << nl + << endl; + } - scalarList tmpFreezeEdges = freezeEdges; - autoPtr<mapPolyMesh> morphMap; + if (checkQuality) + { + Info<< "Selectively disabling wanted collapses until resulting quality" + << " satisfies constraints in system/meshQualityDict" << nl + << endl; + } - while (true) - { - Info<< "Iteration " << nIterations << incrIndent << endl; - labelList boundaryPoint = findBoundaryPoints(fvMeshRef); - List<pointEdgeCollapse> allPointInfo; + // To mark master of collapes + globalIndex globalStrings(mesh.nPoints()); - // Collapse all edges that are too small. - label nSmallCollapsed = - collapseSmallEdges - ( - fvMeshRef, - tmpFreezeEdges, - boundaryPoint, - minLen, - allPointInfo - ); - reduce(nSmallCollapsed, sumOp<label>()); + // Local collapse length. Any edge below this length gets (attempted) + // collapsed. Use either aa gradually decreasing value + // (so from minLen to e.g. 0.5*minLen) or a hard limit (GREAT) + scalarField minEdgeLen(mesh.nEdges(), minLen); + label nFrozenEdges = 0; - Info<< indent << "Collapsing " << nSmallCollapsed - << " small edges" << endl; + // Initial mesh check + // ~~~~~~~~~~~~~~~~~~ + // Do not allow collapses in regions of error. + // Updates minEdgeLen, nFrozenEdges + if (checkQuality) + { + checkMeshAndFreezeEdges + ( + mesh, + identity(mesh.nPoints()), + mesh, + minEdgeLen, + nFrozenEdges + ); + Info<< "Initial frozen edges " + << returnReduce(nFrozenEdges, sumOp<label>()) + << " out of " << returnReduce(mesh.nEdges(), sumOp<label>()) + << endl; + } + // Mark points on boundary + const labelList boundaryPoint = findBoundaryPoints(mesh); - label nMerged = 0; + // Copy of current set of topology changes. Used to generate final mesh. + polyTopoChange savedMeshMod(mesh.boundaryMesh().size()); - // Remove midpoints on straight edges. - if (nSmallCollapsed == 0) - { - //nMerged = mergeEdges(fvMeshRef, maxCos, allPointInfo); - } + // Keep track of whether mesh has changed at all + bool meshChanged = false; - reduce(nMerged, sumOp<label>()); - Info<< indent << "Collapsing " << nMerged << " in line edges" - << endl; + // Main loop + // ~~~~~~~~~ + // It tries and do some collapses, checks the resulting mesh and + // 'freezes' some edges (by marking in minEdgeLen) and tries again. + // This will iterate ultimately to the situation where every edge is + // frozen and nothing gets collapsed. + do + { + // Per edge collapse status: + // -1 : not collapsed + // 0 : collapse to start + // 1 : collapse to end + labelList collapseEdge(mesh.nEdges(), -1); + // Work out which edges to collapse + // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + // This is by looking at minEdgeLen (to avoid frozen edges) + // and marking in collapseEdge. + // Small edges + label nSmallCollapsed = collapseSmallEdges + ( + mesh, + boundaryPoint, + minEdgeLen, + collapseEdge + ); + reduce(nSmallCollapsed, sumOp<label>()); - label nSliversCollapsed = 0; + Info<< indent << "Collapsing " << nSmallCollapsed + << " small edges" << endl; - // Remove small sliver faces that can be collapsed to single edge -// if (nSmallCollapsed == 0 && nMerged == 0) -// { -// nSliversCollapsed = -// collapseHighAspectFaces -// ( -// mesh, -// boundaryPoint, -// processorPoints, -// 1E-9, -// 5, -// collapser -// ); -// } - reduce(nSliversCollapsed, sumOp<label>()); + // Inline edges + label nMerged = mergeEdges + ( + mesh, + maxCos, + boundaryPoint, + minEdgeLen, + collapseEdge + ); + + reduce(nMerged, sumOp<label>()); + Info<< indent << "Collapsing " << nMerged << " in line edges" + << endl; - Info<< indent << "Collapsing " << nSliversCollapsed - << " small high aspect ratio faces" << endl; + // Merge edge collapses into consistent collapse-network. Make sure + // no cells get collapsed. + List<pointEdgeCollapse> allPointInfo; + label nLocalCollapse = consistentCollapse + ( + allowCellCollapse, + mesh, + globalStrings, + collapseEdge, + allPointInfo + ); - // Simplify faces to quads wherever possible - //if (nCollapsed == 0) - //{ - // nCollapsed = - // simplifyFaces - // ( - // mesh, - // boundaryPoint, - // 4, // minimum size of face - // 0.2, // gap in edge lengths on face - // collapser - // ); - // Info<< "Collapsing " << nCollapsed << " polygonal faces" - // << endl; - //} + reduce(nLocalCollapse, sumOp<label>()); + Info<< "nLocalCollapse = " << nLocalCollapse << endl; + if (nLocalCollapse == 0) + { + break; + } - label totalCollapsed = - nSmallCollapsed - + nMerged - + nSliversCollapsed; - polyTopoChange meshMod(fvMeshRef); + // There are collapses so mesh will get changed + meshChanged = true; - // Insert mesh refinement into polyTopoChange. - setRefinement(fvMeshRef, meshMod, allPointInfo); - // Do all changes - Info<< indent << "Applying changes to the mesh" << nl - << decrIndent << endl; + // Apply collapses to current mesh + polyTopoChange meshMod(mesh); - morphMap = meshMod.changeMesh(fvMeshRef, false); + // Insert mesh refinement into polyTopoChange. + setRefinement(mesh, meshMod, allPointInfo); -// // Contains new point label for old points -// const labelList& reversePointMap = morphMap().reversePointMap(); -// -// forAll(pointMap, pI) -// { -// const label originalPoint = pI; -// const label currentPoint = pointMap[pI]; -// -// if (currentPoint < reversePointMap.size()) -// { -// const label newPoint = reversePointMap[currentPoint]; -// -// if (newPoint != -1) -// { -// pointMap[originalPoint] = newPoint; -// } -// } -// } - - if (totalCollapsed == 0) - { - labelHashSet freezePoints = checkMeshQuality(fvMeshRef); + // Do all changes + Info<< indent << "Applying changes to the mesh" << nl + //<< decrIndent + << endl; - label nFreezePoints = freezePoints.size(); - reduce(nFreezePoints, sumOp<label>()); + savedMeshMod = meshMod; - nFrozenEdges = nFreezePoints; + autoPtr<fvMesh> newMeshPtr; + autoPtr<mapPolyMesh> mapPtr = meshMod.makeMesh + ( + newMeshPtr, + IOobject + ( + mesh.name(), + mesh.instance(), + mesh.time(), // register with runTime + IOobject::NO_READ, + IOobject::NO_WRITE, + false + ), + mesh, + true // parallel sync + ); - Info<< "Number of frozen points : " << nFreezePoints - << endl; + fvMesh& newMesh = newMeshPtr(); + const mapPolyMesh& map = mapPtr(); - break; - } + // Update fields + newMesh.updateMesh(map); + if (map.hasMotionPoints()) + { + newMesh.movePoints(map.preMotionPoints()); + } - if (morphMap().hasMotionPoints()) - { - fvMeshRef.movePoints(morphMap().preMotionPoints()); - } - meshChanged = true; - nIterations++; - } - if (nFrozenEdges > 0) + // If no checks needed exit. + if (!checkQuality) { - minLen *= minLenFactor; + break; } - reduce(nFrozenEdges, sumOp<label>()); - - Info<< "Number of frozen edges : " << nFrozenEdges << nl + // Mesh check + // ~~~~~~~~~~~~~~~~~~ + // Do not allow collapses in regions of error. + // Updates minEdgeLen, nFrozenEdges + label nOldFrozenEdges = returnReduce(nFrozenEdges, sumOp<label>()); + checkMeshAndFreezeEdges + ( + newMesh, + map.reversePointMap(), + mesh, + minEdgeLen, + nFrozenEdges + ); + label nNewFrozenEdges = returnReduce(nFrozenEdges, sumOp<label>()); + + Info<< "Frozen edges " + << returnReduce(nFrozenEdges, sumOp<label>()) + << " out of " << returnReduce(mesh.nEdges(), sumOp<label>()) << endl; - if (nFrozenEdges == 0) + if (nNewFrozenEdges == nOldFrozenEdges) { break; } @@ -1409,6 +1413,18 @@ int main(int argc, char *argv[]) if (meshChanged) { + // Apply changes to current mesh + autoPtr<mapPolyMesh> mapPtr = savedMeshMod.changeMesh(mesh, false); + const mapPolyMesh& map = mapPtr(); + + // Update fields + mesh.updateMesh(map); + if (map.hasMotionPoints()) + { + mesh.movePoints(map.preMotionPoints()); + } + + // Write resulting mesh if (!overwrite) { @@ -1416,16 +1432,15 @@ int main(int argc, char *argv[]) } else { - fvMeshPtr().setInstance(oldInstance); + mesh.setInstance(oldInstance); } Info<< nl << "Writing collapsed mesh to time " << runTime.timeName() << nl << endl; - fvMeshPtr().write(); + mesh.write(); } - Info<< "Final minimum length : " << minLen << " m" << nl << endl; Info<< nl << "ExecutionTime = " << runTime.elapsedCpuTime() << " s" << " ClockTime = " << runTime.elapsedClockTime() << " s" diff --git a/applications/utilities/mesh/advanced/collapseEdges/meshQualityDict b/applications/utilities/mesh/advanced/collapseEdges/meshQualityDict new file mode 100644 index 0000000000000000000000000000000000000000..49810f468b818459f7795fb5efad6c1774e2b766 --- /dev/null +++ b/applications/utilities/mesh/advanced/collapseEdges/meshQualityDict @@ -0,0 +1,75 @@ +/*--------------------------------*- C++ -*----------------------------------*\ +| ========= | | +| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | +| \\ / O peration | Version: dev | +| \\ / A nd | Web: http://www.openfoam.org | +| \\/ M anipulation | | +\*---------------------------------------------------------------------------*/ + +FoamFile +{ + version 2.0; + format ascii; + + root ""; + case ""; + instance ""; + local ""; + + class dictionary; + object meshQualityDict; +} + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +//- Maximum non-orthogonality allowed. Set to 180 to disable. +maxNonOrtho 65; + +//- Max skewness allowed. Set to <0 to disable. +maxBoundarySkewness 50; + +//- Max skewness allowed. Set to <0 to disable. +maxInternalSkewness 10; + +//- Max concaveness allowed. Is angle (in degrees) below which concavity +// is allowed. 0 is straight face, <0 would be convex face. +// Set to 180 to disable. +maxConcave 80; + +//- Minimum pyramid volume. Is absolute volume of cell pyramid. +// Set to a sensible fraction of the smallest cell volume expected. +// Set to very negative number (e.g. -1E30) to disable. +minVol 1e-20; + +//- Minimum quality of the tet formed by the face-centre +// and variable base point minimum decomposition triangles and +// the cell centre. This has to be a positive number for tracking +// to work. Set to very negative number (e.g. -1E30) to +// disable. +// <0 = inside out tet, +// 0 = flat tet +// 1 = regular tet +minTetQuality 1e-30; + +//- Minimum face area. Set to <0 to disable. +minArea -1; + +//- Minimum face twist. Set to <-1 to disable. dot product of face normal +//- and face centre triangles normal +minTwist 0.0; + +//- minimum normalised cell determinant +//- 1 = hex, <= 0 = folded or flattened illegal cell +minDeterminant 0.001; + +//- minFaceWeight (0 -> 0.5) +minFaceWeight 0.02; + +//- minVolRatio (0 -> 1) +minVolRatio 0.01; + +//must be >0 for Fluent compatibility +minTriangleTwist -1; + + +// ************************************************************************* // diff --git a/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapseI.H b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapseI.H index a064bcf781dad9cbdbc24f7fc617269f6b355f7f..eeb4d6baf2563a930787d7553c6df34d1dec3d21 100644 --- a/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapseI.H +++ b/applications/utilities/mesh/advanced/collapseEdges/pointEdgeCollapse/pointEdgeCollapseI.H @@ -43,7 +43,7 @@ inline bool Foam::pointEdgeCollapse::update << "problem." << abort(FatalError); } - if (w2.collapseIndex_ == -1) + if (w2.collapseIndex_ == -1 || collapseIndex_ == -1) { // Not marked for collapse; only happens on edges. return false; @@ -56,11 +56,11 @@ inline bool Foam::pointEdgeCollapse::update } else { - // Same coordinate. Same string? + // Take over w2 if it is 'better' + if (w2.collapseIndex_ < collapseIndex_) { - // Take over string index from w2 (and also coordinate but this - // was same) + // Take over string index and coordinate from w2 operator=(w2); return true; } @@ -85,35 +85,6 @@ inline bool Foam::pointEdgeCollapse::update { return false; } - -// if (samePoint(w2.collapsePoint_)) -// { -// // Same coordinate. Same string? -// if (w2.collapseIndex_ < collapseIndex_) -// { -// // Take over string index from w2 (and also coordinate but -// // this was same) -// operator=(w2); -// return true; -// } -// else -// { -// return false; -// } -// } -// else -// { -// // Find nearest coordinate -// if (magSqr(w2.collapsePoint_) < magSqr(collapsePoint_)) -// { -// operator=(w2); -// return true; -// } -// else -// { -// return false; -// } -// } } } diff --git a/applications/utilities/mesh/generation/cvMesh/checkCvMesh/Make/files b/applications/utilities/mesh/generation/cvMesh/checkCvMesh/Make/files deleted file mode 100644 index 73871a7532e1c273d0030d8c8bc4180e1ecef2a7..0000000000000000000000000000000000000000 --- a/applications/utilities/mesh/generation/cvMesh/checkCvMesh/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -checkCvMesh.C - -EXE = $(FOAM_APPBIN)/checkCvMesh diff --git a/applications/utilities/mesh/generation/cvMesh/checkCvMesh/Make/options b/applications/utilities/mesh/generation/cvMesh/checkCvMesh/Make/options deleted file mode 100644 index ba68fd3819b53037f9711dfbb9691846a215f4d3..0000000000000000000000000000000000000000 --- a/applications/utilities/mesh/generation/cvMesh/checkCvMesh/Make/options +++ /dev/null @@ -1,14 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/triSurface/lnInclude \ - -I$(LIB_SRC)/mesh/autoMesh/lnInclude \ - -I$(LIB_SRC)/dynamicMesh/lnInclude \ - -I$(LIB_SRC)/meshTools/lnInclude - -EXE_LIBS = \ - -lfiniteVolume \ - -ldynamicMesh \ - -ltriSurface \ - -lautoMesh \ - -lmeshTools - diff --git a/applications/utilities/mesh/generation/cvMesh/checkCvMesh/checkCvMesh.C b/applications/utilities/mesh/generation/cvMesh/checkCvMesh/checkCvMesh.C deleted file mode 100644 index 88695dbd397056a8d2e33efbcae2fa31a778867d..0000000000000000000000000000000000000000 --- a/applications/utilities/mesh/generation/cvMesh/checkCvMesh/checkCvMesh.C +++ /dev/null @@ -1,122 +0,0 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | - \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation - \\/ 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/>. - -Application - checkCvMesh - -Description - -\*---------------------------------------------------------------------------*/ - -#include "argList.H" -#include "Time.H" -#include "fvMesh.H" -#include "autoSnapDriver.H" -#include "faceSet.H" -#include "motionSmoother.H" -#include "timeSelector.H" - - -using namespace Foam; - - -int main(int argc, char *argv[]) -{ - timeSelector::addOptions(); - -# include "addOverwriteOption.H" - -# include "setRootCase.H" -# include "createTime.H" - - instantList timeDirs = timeSelector::select0(runTime, args); - -# include "createNamedPolyMesh.H" - - runTime.functionObjects().off(); - - forAll(timeDirs, timeI) - { - runTime.setTime(timeDirs[timeI], timeI); - - Info<< "Time = " << runTime.timeName() - << nl << endl; - - mesh.readUpdate(); - - // Check patches and faceZones are synchronised - mesh.boundaryMesh().checkParallelSync(true); - meshRefinement::checkCoupledFaceZones(mesh); - - // Read meshing dictionary - IOdictionary cvMeshDict - ( - IOobject - ( - "cvMeshDict", - runTime.system(), - mesh, - IOobject::MUST_READ_IF_MODIFIED, - IOobject::NO_WRITE - ) - ); - - // mesh motion and mesh quality parameters - const dictionary& meshQualityDict - = cvMeshDict.subDict("meshQualityControls"); - - - Info<< "Checking mesh ..." << endl; - - faceSet wrongFaces(mesh, "wrongFaces", mesh.nFaces()/100); - - motionSmoother::checkMesh(false, mesh, meshQualityDict, wrongFaces); - - const label nInitErrors = returnReduce - ( - wrongFaces.size(), - sumOp<label>() - ); - - Info<< "Detected " << nInitErrors << " illegal faces" - << " (concave, zero area or negative cell pyramid volume)" - << endl; - - if (nInitErrors > 0) - { - Info<< "Writing " << nInitErrors - << " faces in error to set " - << wrongFaces.name() << endl; - - wrongFaces.instance() = mesh.pointsInstance(); - wrongFaces.write(); - } - - Info<< nl << "End of time " << runTime.timeName() << nl << endl; - } - - Info<< "End\n" << endl; - - return 0; -} - diff --git a/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C b/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C index 40adb83035b70fa2b02bf9a154e265e81f06c132..279808bff1f6cc11d6852219ec3ece5ca3b1130f 100644 --- a/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C +++ b/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C @@ -123,14 +123,6 @@ void writeMesh int main(int argc, char *argv[]) { # include "addOverwriteOption.H" - - Foam::argList::addBoolOption - ( - "checkOnly", - "check existing mesh against snappyHexMeshDict settings" - ); - - # include "setRootCase.H" # include "createTime.H" runTime.functionObjects().off(); @@ -141,8 +133,6 @@ int main(int argc, char *argv[]) const bool overwrite = args.optionFound("overwrite"); - const bool checkOnly = args.optionFound("checkOnly"); - // Check patches and faceZones are synchronised mesh.boundaryMesh().checkParallelSync(true); meshRefinement::checkCoupledFaceZones(mesh); @@ -184,36 +174,6 @@ int main(int argc, char *argv[]) ); - if (checkOnly) - { - Info<< "Checking initial mesh ..." << endl; - faceSet wrongFaces(mesh, "wrongFaces", mesh.nFaces()/100); - motionSmoother::checkMesh(false, mesh, motionDict, wrongFaces); - - const label nInitErrors = returnReduce - ( - wrongFaces.size(), - sumOp<label>() - ); - - Info<< "Detected " << nInitErrors << " illegal faces" - << " (concave, zero area or negative cell pyramid volume)" - << endl; - - if (nInitErrors > 0) - { - Info<< "Writing " << nInitErrors - << " faces in error to set " - << wrongFaces.name() << endl; - wrongFaces.instance() = mesh.pointsInstance(); - wrongFaces.write(); - } - - Info<< "End\n" << endl; - - return 0; - } - // Read decomposePar dictionary IOdictionary decomposeDict diff --git a/applications/utilities/mesh/manipulation/checkMesh/Make/files b/applications/utilities/mesh/manipulation/checkMesh/Make/files index f0b7c166946761f10023900d29f2bb92e60b67b6..1a3130a23cd036c78bd36f95c4dd3ba02c6a789f 100644 --- a/applications/utilities/mesh/manipulation/checkMesh/Make/files +++ b/applications/utilities/mesh/manipulation/checkMesh/Make/files @@ -1,6 +1,7 @@ printMeshStats.C checkTopology.C checkGeometry.C +checkMeshQuality.C checkMesh.C EXE = $(FOAM_APPBIN)/checkMesh diff --git a/applications/utilities/mesh/manipulation/checkMesh/Make/options b/applications/utilities/mesh/manipulation/checkMesh/Make/options index 54c035b8f55d183c1ad02bc372398feceaf31718..70c838b774c8b2609363d066e78b1a19b9306ccd 100644 --- a/applications/utilities/mesh/manipulation/checkMesh/Make/options +++ b/applications/utilities/mesh/manipulation/checkMesh/Make/options @@ -1,5 +1,7 @@ EXE_INC = \ - -I$(LIB_SRC)/meshTools/lnInclude + -I$(LIB_SRC)/meshTools/lnInclude \ + -I$(LIB_SRC)/dynamicMesh/lnInclude EXE_LIBS = \ - -lmeshTools + -lmeshTools \ + -ldynamicMesh diff --git a/applications/utilities/mesh/manipulation/checkMesh/checkMesh.C b/applications/utilities/mesh/manipulation/checkMesh/checkMesh.C index 3f0ae4589c97d09f034dd5c81f35736323cdf7f8..dc400f5f415cca10163ea1b62afac8fd80095772 100644 --- a/applications/utilities/mesh/manipulation/checkMesh/checkMesh.C +++ b/applications/utilities/mesh/manipulation/checkMesh/checkMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -27,6 +27,21 @@ Application Description Checks validity of a mesh +Usage + - checkMesh [OPTION] + + \param -allGeometry \n + Checks all (including non finite-volume specific) geometry + + \param -allTopology \n + Checks all (including non finite-volume specific) addressing + + \param -meshQualityDict \n + Checks against user defined (in \a system/meshQualityDict) quality settings + + \param -region \<name\> \n + Specify an alternative mesh region. + \*---------------------------------------------------------------------------*/ #include "argList.H" @@ -39,6 +54,7 @@ Description #include "printMeshStats.H" #include "checkTopology.H" #include "checkGeometry.H" +#include "checkMeshQuality.H" using namespace Foam; @@ -63,6 +79,11 @@ int main(int argc, char *argv[]) "allTopology", "include extra topology checks" ); + argList::addBoolOption + ( + "meshQualityDict", + "read user-defined mesh quality criterions from system/meshQualityDict" + ); # include "setRootCase.H" # include "createTime.H" @@ -72,6 +93,46 @@ int main(int argc, char *argv[]) const bool noTopology = args.optionFound("noTopology"); const bool allGeometry = args.optionFound("allGeometry"); const bool allTopology = args.optionFound("allTopology"); + const bool meshQualityDict = args.optionFound("meshQualityDict"); + + if (noTopology) + { + Info<< "Disabling all topology checks." << nl << endl; + } + if (allTopology) + { + Info<< "Enabling all (cell, face, edge, point) topology checks." + << nl << endl; + } + if (allGeometry) + { + Info<< "Enabling all geometry checks." << nl << endl; + } + if (meshQualityDict) + { + Info<< "Enabling user-defined geometry checks." << nl << endl; + } + + + autoPtr<IOdictionary> qualDict; + if (meshQualityDict) + { + qualDict.reset + ( + new IOdictionary + ( + IOobject + ( + "meshQualityDict", + mesh.time().system(), + mesh, + IOobject::MUST_READ, + IOobject::NO_WRITE + ) + ) + ); + } + forAll(timeDirs, timeI) { @@ -96,25 +157,31 @@ int main(int argc, char *argv[]) printMeshStats(mesh, allTopology); - label noFailedChecks = 0; + label nFailedChecks = 0; if (!noTopology) { - noFailedChecks += checkTopology(mesh, allTopology, allGeometry); + nFailedChecks += checkTopology(mesh, allTopology, allGeometry); + } + + nFailedChecks += checkGeometry(mesh, allGeometry); + + if (meshQualityDict) + { + nFailedChecks += checkMeshQuality(mesh, qualDict()); } - noFailedChecks += checkGeometry(mesh, allGeometry); - // Note: no reduction in noFailedChecks necessary since is + // Note: no reduction in nFailedChecks necessary since is // counter of checks, not counter of failed cells,faces etc. - if (noFailedChecks == 0) + if (nFailedChecks == 0) { Info<< "\nMesh OK.\n" << endl; } else { - Info<< "\nFailed " << noFailedChecks << " mesh checks.\n" + Info<< "\nFailed " << nFailedChecks << " mesh checks.\n" << endl; } } @@ -124,6 +191,12 @@ int main(int argc, char *argv[]) label nFailedChecks = checkGeometry(mesh, allGeometry); + if (meshQualityDict) + { + nFailedChecks += checkMeshQuality(mesh, qualDict()); + } + + if (nFailedChecks) { Info<< "\nFailed " << nFailedChecks << " mesh checks.\n" diff --git a/applications/utilities/mesh/manipulation/checkMesh/checkMeshQuality.C b/applications/utilities/mesh/manipulation/checkMesh/checkMeshQuality.C new file mode 100644 index 0000000000000000000000000000000000000000..b00f02f8ef6ea91ef007af699a5af241df18c27e --- /dev/null +++ b/applications/utilities/mesh/manipulation/checkMesh/checkMeshQuality.C @@ -0,0 +1,34 @@ +#include "checkMeshQuality.H" +#include "polyMesh.H" +#include "cellSet.H" +#include "faceSet.H" +#include "motionSmoother.H" + + +Foam::label Foam::checkMeshQuality +( + const polyMesh& mesh, + const dictionary& dict +) +{ + label noFailedChecks = 0; + + { + faceSet faces(mesh, "meshQualityFaces", mesh.nFaces()/100+1); + motionSmoother::checkMesh(false, mesh, dict, faces); + + label nFaces = returnReduce(faces.size(), sumOp<label>()); + + if (nFaces > 0) + { + noFailedChecks++; + + Info<< " <<Writing " << nFaces + << " faces in error to set " << faces.name() << endl; + faces.instance() = mesh.pointsInstance(); + faces.write(); + } + } + + return noFailedChecks; +} diff --git a/applications/utilities/mesh/manipulation/checkMesh/checkMeshQuality.H b/applications/utilities/mesh/manipulation/checkMesh/checkMeshQuality.H new file mode 100644 index 0000000000000000000000000000000000000000..1e5b3489c9441cf6a8a49b66a39d857782d7e104 --- /dev/null +++ b/applications/utilities/mesh/manipulation/checkMesh/checkMeshQuality.H @@ -0,0 +1,6 @@ +#include "polyMesh.H" + +namespace Foam +{ + label checkMeshQuality(const polyMesh& mesh, const dictionary&); +} diff --git a/applications/utilities/postProcessing/dataConversion/foamToVTK/vtkTopo.C b/applications/utilities/postProcessing/dataConversion/foamToVTK/vtkTopo.C index 6edcb09f982c7d1e462e9e5914a8ebf874cd3c78..f0ef8cd88aaf335d2c407b4a1544bca11befc73e 100644 --- a/applications/utilities/postProcessing/dataConversion/foamToVTK/vtkTopo.C +++ b/applications/utilities/postProcessing/dataConversion/foamToVTK/vtkTopo.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -52,6 +52,7 @@ Foam::vtkTopo::vtkTopo(const polyMesh& mesh) const cellModel& tet = *(cellModeller::lookup("tet")); const cellModel& pyr = *(cellModeller::lookup("pyr")); const cellModel& prism = *(cellModeller::lookup("prism")); + const cellModel& wedge = *(cellModeller::lookup("wedge")); const cellModel& tetWedge = *(cellModeller::lookup("tetWedge")); const cellModel& hex = *(cellModeller::lookup("hex")); @@ -77,7 +78,7 @@ Foam::vtkTopo::vtkTopo(const polyMesh& mesh) if ( model != hex - // && model != wedge // See above. + && model != wedge // See above. && model != prism && model != pyr && model != tet @@ -164,21 +165,21 @@ Foam::vtkTopo::vtkTopo(const polyMesh& mesh) cellTypes_[cellI] = VTK_WEDGE; } -// else if (cellModel == wedge) -// { -// // Treat as squeezed hex -// vtkVerts.setSize(8); -// vtkVerts[0] = cellShape[0]; -// vtkVerts[1] = cellShape[1]; -// vtkVerts[2] = cellShape[2]; -// vtkVerts[3] = cellShape[0]; -// vtkVerts[4] = cellShape[3]; -// vtkVerts[5] = cellShape[4]; -// vtkVerts[6] = cellShape[5]; -// vtkVerts[7] = cellShape[6]; -// -// cellTypes_[cellI] = VTK_HEXAHEDRON; -// } + else if (cellModel == wedge) + { + // Treat as squeezed hex + vtkVerts.setSize(8); + vtkVerts[0] = cellShape[0]; + vtkVerts[1] = cellShape[1]; + vtkVerts[2] = cellShape[2]; + vtkVerts[3] = cellShape[2]; + vtkVerts[4] = cellShape[3]; + vtkVerts[5] = cellShape[4]; + vtkVerts[6] = cellShape[5]; + vtkVerts[7] = cellShape[6]; + + cellTypes_[cellI] = VTK_HEXAHEDRON; + } else if (cellModel == hex) { vtkVerts = cellShape; diff --git a/etc/codeTemplates/source/_Template.C b/etc/codeTemplates/source/_Template.C index 2587eff0a1f29cf03d393cd9df05221105d2fdd0..db0fb9ba1afe9e8c4e25f8626982fdf2b61879e4 100644 --- a/etc/codeTemplates/source/_Template.C +++ b/etc/codeTemplates/source/_Template.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/source/_Template.H b/etc/codeTemplates/source/_Template.H index 5dfa751e3fcad5ec4ac5f882416154ea26e8528f..1226ef835c0ff1514cc2cc48cc61e28164c538db 100644 --- a/etc/codeTemplates/source/_Template.H +++ b/etc/codeTemplates/source/_Template.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/source/_TemplateApp.C b/etc/codeTemplates/source/_TemplateApp.C index 834c4ca8263b341b22006911444f5c7e10b1d481..070100f96e6dcaefdf21a146b6e8c6fc7093a9de 100644 --- a/etc/codeTemplates/source/_TemplateApp.C +++ b/etc/codeTemplates/source/_TemplateApp.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/source/_TemplateI.H b/etc/codeTemplates/source/_TemplateI.H index da5a6787bfe8274f92d0820500a23281a196281d..8de09a51e1848a6fe80ad91172d539194fd9b1f5 100644 --- a/etc/codeTemplates/source/_TemplateI.H +++ b/etc/codeTemplates/source/_TemplateI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/source/_TemplateIO.C b/etc/codeTemplates/source/_TemplateIO.C index 6eef477e7416de6e0c65cdaf6c204ad752348bd9..bb2972330be0573d75699f879d187f0e909074e8 100644 --- a/etc/codeTemplates/source/_TemplateIO.C +++ b/etc/codeTemplates/source/_TemplateIO.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/template/_TemplateTemplate.C b/etc/codeTemplates/template/_TemplateTemplate.C index 98b9748f15d95e42d983d3a34507a58319c8116e..0cd8a3fbc9dc2bc8ad002848fcaecc9f6086d148 100644 --- a/etc/codeTemplates/template/_TemplateTemplate.C +++ b/etc/codeTemplates/template/_TemplateTemplate.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/template/_TemplateTemplate.H b/etc/codeTemplates/template/_TemplateTemplate.H index 783c9e505b9ae87a1650cfb7dbe0201c1e9b53da..8db7a0fc991a6a4f0b895a28790bf219915bec12 100644 --- a/etc/codeTemplates/template/_TemplateTemplate.H +++ b/etc/codeTemplates/template/_TemplateTemplate.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/template/_TemplateTemplateI.H b/etc/codeTemplates/template/_TemplateTemplateI.H index da5a6787bfe8274f92d0820500a23281a196281d..8de09a51e1848a6fe80ad91172d539194fd9b1f5 100644 --- a/etc/codeTemplates/template/_TemplateTemplateI.H +++ b/etc/codeTemplates/template/_TemplateTemplateI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/etc/codeTemplates/template/_TemplateTemplateIO.C b/etc/codeTemplates/template/_TemplateTemplateIO.C index 456d28ba8e24b414f647340afffc8860c530e107..8a5e6e56c43f1792fa4703738b0efec18a439589 100644 --- a/etc/codeTemplates/template/_TemplateTemplateIO.C +++ b/etc/codeTemplates/template/_TemplateTemplateIO.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License diff --git a/src/OpenFOAM/db/IOstreams/Pstreams/UIPstream.C b/src/OpenFOAM/db/IOstreams/Pstreams/UIPstream.C index 3e095272db4f010dd1bb1b235c9e6bebb2e5e2d5..2167d15b6defd06cdbb936c7cefe3b8630b47fe5 100644 --- a/src/OpenFOAM/db/IOstreams/Pstreams/UIPstream.C +++ b/src/OpenFOAM/db/IOstreams/Pstreams/UIPstream.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -165,8 +165,14 @@ Foam::Istream& Foam::UIPstream::read(token& t) } // String - case token::STRING : case token::VERBATIMSTRING : + { + // Recurse to read actual string + read(t); + t.type() = token::VERBATIMSTRING; + return *this; + } + case token::STRING : { string* pval = new string; if (read(*pval)) diff --git a/src/OpenFOAM/db/IOstreams/Pstreams/UOPstream.C b/src/OpenFOAM/db/IOstreams/Pstreams/UOPstream.C index c257826c0473d286c03b3a253a19ba2702570a2b..e01e8de01bdbb307cb560570e8a64062c10f32d8 100644 --- a/src/OpenFOAM/db/IOstreams/Pstreams/UOPstream.C +++ b/src/OpenFOAM/db/IOstreams/Pstreams/UOPstream.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -151,10 +151,19 @@ Foam::UOPstream::~UOPstream() // * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * * // -Foam::Ostream& Foam::UOPstream::write(const token&) +Foam::Ostream& Foam::UOPstream::write(const token& t) { - notImplemented("Ostream& UOPstream::write(const token&)"); - setBad(); + // Raw token output only supported for verbatim strings for now + if (t.type() == token::VERBATIMSTRING) + { + write(char(token::VERBATIMSTRING)); + write(t.stringToken()); + } + else + { + notImplemented("Ostream& UOPstream::write(const token&)"); + setBad(); + } return *this; } diff --git a/src/OpenFOAM/db/IOstreams/Sstreams/OSstream.C b/src/OpenFOAM/db/IOstreams/Sstreams/OSstream.C index 2dbf0c1150573e2053dab29ee0a73f83cc64c3a3..4cbf8bf1fa98563fbae17ff2b72f75add6564237 100644 --- a/src/OpenFOAM/db/IOstreams/Sstreams/OSstream.C +++ b/src/OpenFOAM/db/IOstreams/Sstreams/OSstream.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -29,8 +29,16 @@ License // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // -Foam::Ostream& Foam::OSstream::write(const token&) +Foam::Ostream& Foam::OSstream::write(const token& t) { + if (t.type() == token::VERBATIMSTRING) + { + write(char(token::HASH)); + write(char(token::BEGIN_BLOCK)); + writeQuoted(t.stringToken(), false); + write(char(token::HASH)); + write(char(token::END_BLOCK)); + } return *this; } diff --git a/src/OpenFOAM/db/IOstreams/Sstreams/prefixOSstream.C b/src/OpenFOAM/db/IOstreams/Sstreams/prefixOSstream.C index b46a9b81092be7aacd2070e1d2dec61fb42deb97..7ca977bf978562fe0cf2c843cac473149be199ac 100644 --- a/src/OpenFOAM/db/IOstreams/Sstreams/prefixOSstream.C +++ b/src/OpenFOAM/db/IOstreams/Sstreams/prefixOSstream.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -65,8 +65,16 @@ void Foam::prefixOSstream::print(Ostream& os) const } -Foam::Ostream& Foam::prefixOSstream::write(const token&) +Foam::Ostream& Foam::prefixOSstream::write(const token& t) { + if (t.type() == token::VERBATIMSTRING) + { + write(char(token::HASH)); + write(char(token::BEGIN_BLOCK)); + writeQuoted(t.stringToken(), false); + write(char(token::HASH)); + write(char(token::END_BLOCK)); + } return *this; } diff --git a/src/OpenFOAM/db/dictionary/primitiveEntry/primitiveEntryIO.C b/src/OpenFOAM/db/dictionary/primitiveEntry/primitiveEntryIO.C index 021f146536f2afa3e3ef73068c30a73d38bfb9fd..fd442af47ae05dff20276f68e2a4bd02addf3ce4 100644 --- a/src/OpenFOAM/db/dictionary/primitiveEntry/primitiveEntryIO.C +++ b/src/OpenFOAM/db/dictionary/primitiveEntry/primitiveEntryIO.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -225,9 +225,9 @@ void Foam::primitiveEntry::write(Ostream& os, const bool contentsOnly) const const token& t = operator[](i); if (t.type() == token::VERBATIMSTRING) { - os << token::HASH << token::BEGIN_BLOCK; - os.writeQuoted(t.stringToken(), false); - os << token::HASH << token::END_BLOCK; + // Bypass token output operator to avoid losing verbatimness. + // Handle in Ostreams themselves + os.write(t); } else { diff --git a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshCheck.C b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshCheck.C index bf103c225420e5a45add6e802caf3c347d7dda0f..b180a5965b6174f2c11ec0efd85893c3a62d9b56 100644 --- a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshCheck.C +++ b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshCheck.C @@ -25,7 +25,6 @@ License #include "primitiveMesh.H" #include "pyramidPointFaceRef.H" -#include "tetrahedron.H" #include "ListOps.H" #include "unitConversion.H" #include "SortableList.H" diff --git a/src/dynamicMesh/createShellMesh/Make/files b/src/dynamicMesh/createShellMesh/Make/files deleted file mode 100644 index 4aa716f0220d590095857d4d07940c486a3b4ea3..0000000000000000000000000000000000000000 --- a/src/dynamicMesh/createShellMesh/Make/files +++ /dev/null @@ -1,3 +0,0 @@ -createShellMesh.C - -LIB = $(FOAM_LIBBIN)/libcreateShellMesh diff --git a/src/dynamicMesh/createShellMesh/Make/options b/src/dynamicMesh/createShellMesh/Make/options deleted file mode 100644 index 295f0b0bc956185f982b81ddf6eaa4e2869850e1..0000000000000000000000000000000000000000 --- a/src/dynamicMesh/createShellMesh/Make/options +++ /dev/null @@ -1,9 +0,0 @@ -EXE_INC = \ - -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/meshTools/lnInclude \ - -I$(LIB_SRC)/dynamicMesh/lnInclude -DFULLDEBUG -g -O0 - -LIB_LIBS = \ - -lfiniteVolume \ - -lmeshTools \ - -ldynamicMesh diff --git a/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.C b/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.C index c13720b831923e6f251b0885d24948d76b9757fa..02bd8ae0dcb5b2e30907a2120edeba845e78ab9c 100644 --- a/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.C +++ b/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.C @@ -83,7 +83,8 @@ Foam::pressureGradientExplicitSource::pressureGradientExplicitSource Ubar_(coeffs_.lookup("Ubar")), gradPini_(coeffs_.lookup("gradPini")), gradP_(gradPini_), - flowDir_(Ubar_/mag(Ubar_)) + flowDir_(Ubar_/mag(Ubar_)), + invAPtr_(NULL) { coeffs_.lookup("fieldNames") >> fieldNames_; @@ -124,36 +125,9 @@ Foam::pressureGradientExplicitSource::pressureGradientExplicitSource // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // -void Foam::pressureGradientExplicitSource::addSup -( - fvMatrix<vector>& eqn, - const label fieldI -) -{ - DimensionedField<vector, volMesh> Su - ( - IOobject - ( - name_ + fieldNames_[fieldI] + "Sup", - mesh_.time().timeName(), - mesh_, - IOobject::NO_READ, - IOobject::NO_WRITE - ), - mesh_, - dimensionedVector("zero", gradP_.dimensions(), vector::zero) - ); - - UIndirectList<vector>(Su, cells_) = flowDir_*gradP_.value(); - - eqn += Su; -} - - void Foam::pressureGradientExplicitSource::correct(volVectorField& U) { - const volScalarField& rAU = - mesh_.lookupObject<volScalarField>("(1|A(" + U.name() + "))"); + const scalarField& rAU = invAPtr_().internalField(); // Integrate flow variables over cell set scalar magUbarAve = 0.0; @@ -196,4 +170,61 @@ void Foam::pressureGradientExplicitSource::correct(volVectorField& U) } +void Foam::pressureGradientExplicitSource::addSup +( + fvMatrix<vector>& eqn, + const label fieldI +) +{ + DimensionedField<vector, volMesh> Su + ( + IOobject + ( + name_ + fieldNames_[fieldI] + "Sup", + mesh_.time().timeName(), + mesh_, + IOobject::NO_READ, + IOobject::NO_WRITE + ), + mesh_, + dimensionedVector("zero", gradP_.dimensions(), vector::zero) + ); + + UIndirectList<vector>(Su, cells_) = flowDir_*gradP_.value(); + + eqn += Su; +} + + +void Foam::pressureGradientExplicitSource::setValue +( + fvMatrix<vector>& eqn, + const label +) +{ + if (invAPtr_.empty()) + { + invAPtr_.reset + ( + new volScalarField + ( + IOobject + ( + name_ + "::invA", + mesh_.time().timeName(), + mesh_, + IOobject::NO_READ, + IOobject::NO_WRITE + ), + 1.0/eqn.A() + ) + ); + } + else + { + invAPtr_() = 1.0/eqn.A(); + } +} + + // ************************************************************************* // diff --git a/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.H b/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.H index 48b4bf2c24e0f2657033a85e49ac46b9cd7cf963..a45a7927de90e9267a0c534d53783ed4d7405ad5 100644 --- a/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.H +++ b/src/fieldSources/basicSource/pressureGradientExplicitSource/pressureGradientExplicitSource.H @@ -33,7 +33,7 @@ Description pressureGradientExplicitSourceCoeffs { - UName U; // name of velocity field + fieldNames (U); // name of velocity field Ubar (10.0 0 0); // desired average velocity gradPini gradPini [0 2 -2 0 0] 0; // initial pressure gradient flowDir (1 0 0); // flow direction @@ -82,6 +82,9 @@ class pressureGradientExplicitSource //- Flow direction vector flowDir_; + //- Matrix 1/A coefficients field pointer + autoPtr<volScalarField> invAPtr_; + // Private Member Functions @@ -126,6 +129,13 @@ public: //- Add explicit contribution to equation virtual void addSup(fvMatrix<vector>& eqn, const label fieldI); + //- Set 1/A coefficient + virtual void setValue + ( + fvMatrix<vector>& eqn, + const label fieldI + ); + // I-O diff --git a/src/fieldSources/basicSource/rotorDiskSource/profileModel/lookup/lookupProfile.C b/src/fieldSources/basicSource/rotorDiskSource/profileModel/lookup/lookupProfile.C index ae80d03995d4e11bd5bd17043650240e70f31876..1dda6b403b3e75d3de54a39461d1a3fab8d72ec9 100644 --- a/src/fieldSources/basicSource/rotorDiskSource/profileModel/lookup/lookupProfile.C +++ b/src/fieldSources/basicSource/rotorDiskSource/profileModel/lookup/lookupProfile.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -65,9 +65,9 @@ void Foam::lookupProfile::interpolateWeights ddx = 0.0; return; } - else if (i2 == values.size()) + else if (i2 == nElem) { - i2 = values.size() - 1; + i2 = nElem - 1; i1 = i2; ddx = 0.0; return; diff --git a/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.C b/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.C index fb695078255d7f5015a3c85e9ce96a80473914ab..5c8a20c108d02e5b79e2ff97ab9668651cb4cd6c 100644 --- a/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.C +++ b/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.C @@ -38,7 +38,7 @@ namespace Foam // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // -Foam::scalar Foam::seriesProfile::evaluate +Foam::scalar Foam::seriesProfile::evaluateDrag ( const scalar& xIn, const List<scalar>& values @@ -48,7 +48,26 @@ Foam::scalar Foam::seriesProfile::evaluate forAll(values, i) { - result += values[i]*sin((i + 1)*xIn); + result += values[i]*cos(i*xIn); + } + + return result; +} + + +Foam::scalar Foam::seriesProfile::evaluateLift +( + const scalar& xIn, + const List<scalar>& values +) const +{ + scalar result = 0.0; + + forAll(values, i) + { + // note: first contribution always zero since sin(0) = 0, but + // keep zero base to be consitent with drag coeffs + result += values[i]*sin(i*xIn); } return result; @@ -108,8 +127,8 @@ Foam::seriesProfile::seriesProfile void Foam::seriesProfile::Cdl(const scalar alpha, scalar& Cd, scalar& Cl) const { - Cd = evaluate(alpha, CdCoeffs_); - Cl = evaluate(alpha, ClCoeffs_); + Cd = evaluateDrag(alpha, CdCoeffs_); + Cl = evaluateLift(alpha, ClCoeffs_); } diff --git a/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.H b/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.H index 7c4793e28e9fbe954dd6bf72af0a22c314038665..5e2611d6c3a0503683e916f326a591333f2f2786 100644 --- a/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.H +++ b/src/fieldSources/basicSource/rotorDiskSource/profileModel/series/seriesProfile.H @@ -28,7 +28,7 @@ Description Series-up based profile data - drag and lift coefficients computed as sum of cosine series - Cd = sum_i(CdCoeff)*sin(i*AOA) + Cd = sum_i(CdCoeff)*cos(i*AOA) Cl = sum_i(ClCoeff)*sin(i*AOA) where: @@ -79,12 +79,21 @@ protected: // Protected Member Functions - //- Evaluate - scalar evaluate - ( - const scalar& xIn, - const List<scalar>& values - ) const; + // Evaluate + + //- Drag + scalar evaluateDrag + ( + const scalar& xIn, + const List<scalar>& values + ) const; + + //- Lift + scalar evaluateLift + ( + const scalar& xIn, + const List<scalar>& values + ) const; public: diff --git a/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.C b/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.C index e6381c543b85a280753e53e67f3ae812e09a6c85..20161147df03ba270214f9ca43515fa7d9415a3f 100644 --- a/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.C +++ b/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.C @@ -446,15 +446,15 @@ Foam::rotorDiskSource::rotorDiskSource inletVelocity_(vector::zero), tipEffect_(1.0), flap_(), - trim_(trimModel::New(*this, coeffs_)), - blade_(coeffs_.subDict("blade")), - profiles_(coeffs_.subDict("profiles")), x_(cells_.size(), vector::zero), R_(cells_.size(), I), invR_(cells_.size(), I), area_(cells_.size(), 0.0), coordSys_(false), - rMax_(0.0) + rMax_(0.0), + trim_(trimModel::New(*this, coeffs_)), + blade_(coeffs_.subDict("blade")), + profiles_(coeffs_.subDict("profiles")) { read(dict); } @@ -521,9 +521,16 @@ void Foam::rotorDiskSource::calculate scalar invDr = 0.0; blade_.interpolate(radius, twist, chord, i1, i2, invDr); + // flip geometric angle if blade is spinning in reverse (clockwise) + scalar alphaGeom = alphag[i] + twist; + if (omega_ < 0) + { + alphaGeom = mathematical::pi - alphaGeom; + } + // effective angle of attack scalar alphaEff = - mathematical::pi + atan2(Uc.z(), Uc.y()) - (alphag[i] + twist); + mathematical::pi + atan2(Uc.z(), Uc.y()) - alphaGeom; if (alphaEff > mathematical::pi) { diff --git a/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.H b/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.H index 2df09f9f7bb3224df9f5afebcffad5fd08dec50e..8e26425e10799c90efeb69da689bce5ad51fabaf 100644 --- a/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.H +++ b/src/fieldSources/basicSource/rotorDiskSource/rotorDiskSource.H @@ -149,6 +149,7 @@ protected: word rhoName_; //- Rotational speed [rad/s] + // Positive anti-clockwise when looking along -ve lift direction scalar omega_; //- Number of blades @@ -167,15 +168,6 @@ protected: //- Blade flap coefficients [rad/s] flapData flap_; - //- Trim model - autoPtr<trimModel> trim_; - - //- Blade data - bladeModel blade_; - - //- Profile data - profileModelList profiles_; - //- Cell centre positions in local rotor frame // (Cylindrical r, theta, z) List<point> x_; @@ -195,6 +187,15 @@ protected: //- Maximum radius scalar rMax_; + //- Trim model + autoPtr<trimModel> trim_; + + //- Blade data + bladeModel blade_; + + //- Profile data + profileModelList profiles_; + // Protected Member Functions diff --git a/src/fieldSources/basicSource/rotorDiskSource/trimModel/fixed/fixedTrim.C b/src/fieldSources/basicSource/rotorDiskSource/trimModel/fixed/fixedTrim.C index 4d8f1499e54e0fc5c0fbcbfe959b37c0d3a16693..d5f4843d587c7ad74427bebad02ff55cb678ec93 100644 --- a/src/fieldSources/basicSource/rotorDiskSource/trimModel/fixed/fixedTrim.C +++ b/src/fieldSources/basicSource/rotorDiskSource/trimModel/fixed/fixedTrim.C @@ -67,7 +67,7 @@ void Foam::fixedTrim::read(const dictionary& dict) scalar theta1c = degToRad(readScalar(coeffs_.lookup("theta1c"))); scalar theta1s = degToRad(readScalar(coeffs_.lookup("theta1s"))); - const List<vector>& x = rotor_.x(); + const List<point>& x = rotor_.x(); forAll(thetag_, i) { scalar psi = x[i].y(); diff --git a/src/finiteVolume/Make/files b/src/finiteVolume/Make/files index 3691354d0bce17a25fe23fc7d03206b80910225a..22988f32169a94d03186bcb7328e24f85c13294e 100644 --- a/src/finiteVolume/Make/files +++ b/src/finiteVolume/Make/files @@ -174,6 +174,7 @@ $(derivedFvPatchFields)/waveSurfacePressure/waveSurfacePressureFvPatchScalarFiel $(derivedFvPatchFields)/phaseHydrostaticPressure/phaseHydrostaticPressureFvPatchScalarField.C $(derivedFvPatchFields)/variableHeightFlowRate/variableHeightFlowRateFvPatchField.C $(derivedFvPatchFields)/variableHeightFlowRateInletVelocity/variableHeightFlowRateInletVelocityFvPatchVectorField.C +$(derivedFvPatchFields)/temperatureJump/temperatureJumpFvPatchScalarField.C fvsPatchFields = fields/fvsPatchFields $(fvsPatchFields)/fvsPatchField/fvsPatchFields.C diff --git a/src/finiteVolume/fields/fvPatchFields/constraint/wedge/wedgeFvPatchScalarField.C b/src/finiteVolume/fields/fvPatchFields/constraint/wedge/wedgeFvPatchScalarField.C index e3ca2d79e966fdca502f89c1dd669fa00b091cb0..c82ed7f7a6706ed7c6bf4d27c7ce8a7893781c66 100644 --- a/src/finiteVolume/fields/fvPatchFields/constraint/wedge/wedgeFvPatchScalarField.C +++ b/src/finiteVolume/fields/fvPatchFields/constraint/wedge/wedgeFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -48,7 +48,7 @@ void wedgeFvPatchField<scalar>::evaluate(const Pstream::commsTypes) updateCoeffs(); } - operator==(patchInternalField()); + this->operator==(patchInternalField()); } diff --git a/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C index 0348035314a56cd6c69b6812065d92c2e93695e3..d41c428e74bc63a6a5f4f337da15ed67e93f54dd 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C +++ b/src/finiteVolume/fields/fvPatchFields/derived/cylindricalInletVelocity/cylindricalInletVelocityFvPatchVectorField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -132,7 +132,7 @@ void Foam::cylindricalInletVelocityFvPatchVectorField::updateCoeffs() vector hatAxis = axis_/mag(axis_); const vectorField r(patch().Cf() - centre_); - tmp<vectorField> d = r - (hatAxis & r)*hatAxis; + const vectorField d = r - (hatAxis & r)*hatAxis; tmp<vectorField> tangVel ( diff --git a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C index c64b616a864afdc67ce8d382dbb5f3d79ff62aa5..64c1120cc9c99cea3c385d6cf2d904137f376e67 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C +++ b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C @@ -129,11 +129,19 @@ void Foam::flowRateInletVelocityFvPatchVectorField::updateCoeffs() } else if (phi.dimensions() == dimDensity*dimVelocity*dimArea) { - const fvPatchField<scalar>& rhop = - patch().lookupPatchField<volScalarField, scalar>(rhoName_); - - // mass flow-rate - operator==(n*avgU/rhop); + if (rhoName_ == "none") + { + // volumetric flow-rate if density not given + operator==(n*avgU); + } + else + { + // mass flow-rate + const fvPatchField<scalar>& rhop = + patch().lookupPatchField<volScalarField, scalar>(rhoName_); + + operator==(n*avgU/rhop); + } } else { diff --git a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.H b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.H index f40674ea01c8387a6299e92242795192f8e94d84..7410e5290fbdad88aeb7889bbbbb85146374fd71 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.H @@ -30,8 +30,10 @@ Description The basis of the patch (volumetric or mass) is determined by the dimensions of the flux, phi. - The current density is used to correct the velocity when applying the - mass basis. + + If the flux is mass-based + - the current density is used to correct the velocity + - volumetric flow rate can be applied by setting the 'rho' entry to 'none' Example of the boundary condition specification: \verbatim @@ -39,6 +41,7 @@ Description { type flowRateInletVelocity; flowRate 0.2; // Volumetric/mass flow rate [m3/s or kg/s] + rho rho; // none | rho [m3/s or kg/s] value uniform (0 0 0); // placeholder } \endverbatim diff --git a/src/finiteVolume/fields/fvPatchFields/derived/temperatureJump/temperatureJumpFvPatchScalarField.C b/src/finiteVolume/fields/fvPatchFields/derived/temperatureJump/temperatureJumpFvPatchScalarField.C new file mode 100644 index 0000000000000000000000000000000000000000..99be42e3d6fc610f434fb8db65acb9889266dfbf --- /dev/null +++ b/src/finiteVolume/fields/fvPatchFields/derived/temperatureJump/temperatureJumpFvPatchScalarField.C @@ -0,0 +1,129 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation + \\/ 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 "addToRunTimeSelectionTable.H" +#include "temperatureJumpFvPatchScalarField.H" +#include "volFields.H" + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam::temperatureJumpFvPatchScalarField::temperatureJumpFvPatchScalarField +( + const fvPatch& p, + const DimensionedField<scalar, volMesh>& iF +) +: + fixedJumpFvPatchField<scalar>(p, iF), + jumpTable_(0) +{} + + +Foam::temperatureJumpFvPatchScalarField::temperatureJumpFvPatchScalarField +( + const temperatureJumpFvPatchScalarField& ptf, + const fvPatch& p, + const DimensionedField<scalar, volMesh>& iF, + const fvPatchFieldMapper& mapper +) +: + fixedJumpFvPatchField<scalar>(ptf, p, iF, mapper), + jumpTable_(ptf.jumpTable_().clone().ptr()) +{} + + +Foam::temperatureJumpFvPatchScalarField::temperatureJumpFvPatchScalarField +( + const fvPatch& p, + const DimensionedField<scalar, volMesh>& iF, + const dictionary& dict +) +: + fixedJumpFvPatchField<scalar>(p, iF), + jumpTable_(new DataEntry<scalar>("jumpTable")) +{ + + if (this->cyclicPatch().owner()) + { + jumpTable_ = DataEntry<scalar>::New("jumpTable", dict); + } + + if (dict.found("value")) + { + fvPatchScalarField::operator= + ( + scalarField("value", dict, p.size()) + ); + } +} + + +Foam::temperatureJumpFvPatchScalarField::temperatureJumpFvPatchScalarField +( + const temperatureJumpFvPatchScalarField& ptf +) +: + cyclicLduInterfaceField(), + fixedJumpFvPatchField<scalar>(ptf), + jumpTable_(ptf.jumpTable_().clone().ptr()) +{} + + +Foam::temperatureJumpFvPatchScalarField::temperatureJumpFvPatchScalarField +( + const temperatureJumpFvPatchScalarField& ptf, + const DimensionedField<scalar, volMesh>& iF +) +: + fixedJumpFvPatchField<scalar>(ptf, iF), + jumpTable_(ptf.jumpTable_().clone().ptr()) +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + + +void Foam::temperatureJumpFvPatchScalarField::write(Ostream& os) const +{ + fixedJumpFvPatchField<scalar>::write(os); + if (this->cyclicPatch().owner()) + { + jumpTable_->writeData(os); + } + this->writeEntry("value", os); +} + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + makePatchTypeField + ( + fvPatchScalarField, + temperatureJumpFvPatchScalarField + ); +} + +// ************************************************************************* // diff --git a/src/finiteVolume/fields/fvPatchFields/derived/temperatureJump/temperatureJumpFvPatchScalarField.H b/src/finiteVolume/fields/fvPatchFields/derived/temperatureJump/temperatureJumpFvPatchScalarField.H new file mode 100644 index 0000000000000000000000000000000000000000..55364eac5d23dd54cdd62af3c6b8494fda4a5635 --- /dev/null +++ b/src/finiteVolume/fields/fvPatchFields/derived/temperatureJump/temperatureJumpFvPatchScalarField.H @@ -0,0 +1,159 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation + \\/ 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/>. + +Class + Foam::temperatureJumpFvPatchScalarField + +Description + Introduce a jump in temperature on a cycle patch + front + { + type temperatureJump; + patchType cyclic; + jumpTable constant 100; + value uniform 300; + } + +SourceFiles + temperatureJumpFvPatchScalarField.C + +\*---------------------------------------------------------------------------*/ + +#ifndef temperatureJumpFvPatchScalarField_H +#define temperatureJumpFvPatchScalarField_H + +#include "fixedJumpFvPatchField.H" +#include "DataEntry.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +/*---------------------------------------------------------------------------*\ + Class temperatureJumpFvPatchScalarField Declaration +\*---------------------------------------------------------------------------*/ + +class temperatureJumpFvPatchScalarField +: + public fixedJumpFvPatchField<scalar> +{ + + // Private data + + //- Interpolation table + autoPtr<DataEntry<scalar> > jumpTable_; + + +public: + + //- Runtime type information + TypeName("temperatureJump"); + + // Constructors + + //- Construct from patch and internal field + temperatureJumpFvPatchScalarField + ( + const fvPatch&, + const DimensionedField<scalar, volMesh>& + ); + + //- Construct from patch, internal field and dictionary + temperatureJumpFvPatchScalarField + ( + const fvPatch&, + const DimensionedField<scalar, volMesh>&, + const dictionary& + ); + + //- Construct by mapping given temperatureJumpFvPatchScalarField onto a + // new patch + temperatureJumpFvPatchScalarField + ( + const temperatureJumpFvPatchScalarField&, + const fvPatch&, + const DimensionedField<scalar, volMesh>&, + const fvPatchFieldMapper& + ); + + //- Construct as copy + temperatureJumpFvPatchScalarField + ( + const temperatureJumpFvPatchScalarField& + ); + + //- Construct and return a clone + virtual tmp<fvPatchField<scalar> > clone() const + { + return tmp<fvPatchField<scalar> > + ( + new temperatureJumpFvPatchScalarField(*this) + ); + } + + //- Construct as copy setting internal field reference + temperatureJumpFvPatchScalarField + ( + const temperatureJumpFvPatchScalarField&, + const DimensionedField<scalar, volMesh>& + ); + + //- Construct and return a clone setting internal field reference + virtual tmp<fvPatchField<scalar> > clone + ( + const DimensionedField<scalar, volMesh>& iF + ) const + { + return tmp<fvPatchField<scalar> > + ( + new temperatureJumpFvPatchScalarField(*this, iF) + ); + } + + + // Member functions + + + // Access functions + + //- Return jumpTable + const DataEntry<scalar>& jumpTable() const + { + return jumpTable_(); + } + + + //- Write + virtual void write(Ostream&) const; +}; + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollisionRecordList/CollisionRecordList.H b/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollisionRecordList/CollisionRecordList.H index ae5cc47c10a5a6a596bcfd8cf5a484e439b8f1cc..57546dfc2e50506e123d1f1200fae019bebd6140 100644 --- a/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollisionRecordList/CollisionRecordList.H +++ b/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollisionRecordList/CollisionRecordList.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -85,6 +85,7 @@ class CollisionRecordList //- List of active wall collisions DynamicList<WallCollisionRecord<WallType> > wallRecords_; + public: // Constructors @@ -115,11 +116,11 @@ public: //- Return the active pair collisions inline const DynamicList<PairCollisionRecord<PairType> >& - pairRecords() const; + pairRecords() const; //- Return the active wall collisions inline const DynamicList<WallCollisionRecord<WallType> >& - wallRecords() const; + wallRecords() const; // Fields representing the data from each record, i.e if the // records 0-N containing each data members {a, b, c, d...} diff --git a/src/lagrangian/intermediate/parcels/Templates/ReactingParcel/ReactingParcel.C b/src/lagrangian/intermediate/parcels/Templates/ReactingParcel/ReactingParcel.C index 88acc1a9af2f6a88c5dd3efc6150b21bbe646078..538ef84c82bbe319ca893406176a4667fd7883fc 100644 --- a/src/lagrangian/intermediate/parcels/Templates/ReactingParcel/ReactingParcel.C +++ b/src/lagrangian/intermediate/parcels/Templates/ReactingParcel/ReactingParcel.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -80,12 +80,15 @@ void Foam::ReactingParcel<ParcelType>::cellValueSourceCorrection ) { scalar addedMass = 0.0; + scalar maxMassI = 0.0; forAll(td.cloud().rhoTrans(), i) { - addedMass += td.cloud().rhoTrans(i)[cellI]; + scalar dm = td.cloud().rhoTrans(i)[cellI]; + maxMassI = max(maxMassI, mag(dm)); + addedMass += dm; } - if (addedMass < ROOTVSMALL) + if (maxMassI < ROOTVSMALL) { return; } @@ -95,16 +98,13 @@ void Foam::ReactingParcel<ParcelType>::cellValueSourceCorrection this->rhoc_ += addedMass/td.cloud().pMesh().cellVolumes()[cellI]; const scalar massCellNew = massCell + addedMass; - this->Uc_ += td.cloud().UTrans()[cellI]/massCellNew; + this->Uc_ = (this->Uc_*massCell + td.cloud().UTrans()[cellI])/massCellNew; scalar CpEff = 0.0; - if (addedMass > ROOTVSMALL) + forAll(td.cloud().rhoTrans(), i) { - forAll(td.cloud().rhoTrans(), i) - { - scalar Y = td.cloud().rhoTrans(i)[cellI]/addedMass; - CpEff += Y*td.cloud().composition().carrier().Cp(i, this->Tc_); - } + scalar Y = td.cloud().rhoTrans(i)[cellI]/addedMass; + CpEff += Y*td.cloud().composition().carrier().Cp(i, this->Tc_); } const scalar Cpc = td.CpInterp().psi()[cellI]; @@ -152,7 +152,7 @@ void Foam::ReactingParcel<ParcelType>::correctSurfaceValues ) { // No correction if total concentration of emitted species is small - if (sum(Cs) < SMALL) + if (!td.cloud().heatTransfer().BirdCorrection() || (sum(Cs) < SMALL)) { return; } diff --git a/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C b/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C index 7eb6e8cfeeff6aa1c369c357a7a998fe2230d997..0732e5004e8fefb00333616b0c0e3da3fff37f38 100644 --- a/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C +++ b/src/lagrangian/intermediate/submodels/Kinematic/SurfaceFilmModel/SurfaceFilmModel/SurfaceFilmModel.C @@ -238,7 +238,7 @@ void Foam::SurfaceFilmModel<CloudType>::cacheFilmFields diameterParcelPatch_ = filmModel.cloudDiameterTrans().boundaryField()[filmPatchI]; - filmModel.toPrimary(filmPatchI, diameterParcelPatch_, maxOp<scalar>()); + filmModel.toPrimary(filmPatchI, diameterParcelPatch_, maxEqOp<scalar>()); UFilmPatch_ = filmModel.Us().boundaryField()[filmPatchI]; filmModel.toPrimary(filmPatchI, UFilmPatch_); diff --git a/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.C b/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.C index 1739f7c90714229d69b1521d83da21eb87f31ffc..046adb8a2a08946a852c2409e8e9ac28eeeef309 100644 --- a/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.C +++ b/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.C @@ -59,16 +59,16 @@ namespace Foam }; //- Combine operator for interpolateToSource/Target - template<class Type, class BinaryOp> + template<class Type, class CombineOp> class combineBinaryOp { - const BinaryOp& bop_; + const CombineOp& cop_; public: - combineBinaryOp(const BinaryOp& bop) + combineBinaryOp(const CombineOp& cop) : - bop_(bop) + cop_(cop) {} void operator() @@ -79,7 +79,7 @@ namespace Foam const scalar weight ) const { - x = bop_(x, weight*y); + cop_(x, weight*y); } }; } @@ -917,22 +917,23 @@ Foam::scalar Foam::AMIInterpolation<SourcePatch, TargetPatch>::interArea const primitivePatch& tgtPatch ) const { + const pointField& srcPoints = srcPatch.points(); + const pointField& tgtPoints = tgtPatch.points(); + + // references to candidate faces + const face& src = srcPatch[srcFaceI]; + const face& tgt = tgtPatch[tgtFaceI]; + // quick reject if either face has zero area - if (srcMagSf_[srcFaceI] < ROOTVSMALL || tgtMagSf_[tgtFaceI] < ROOTVSMALL) + // Note: do not used stored face areas for target patch + if ((srcMagSf_[srcFaceI] < ROOTVSMALL) || (tgt.mag(tgtPoints) < ROOTVSMALL)) { return 0.0; } - const pointField& srcPoints = srcPatch.points(); - const pointField& tgtPoints = tgtPatch.points(); - // create intersection object faceAreaIntersect inter(srcPoints, tgtPoints, reverseTarget_); - // references to candidate faces - const face& src = srcPatch[srcFaceI]; - const face& tgt = tgtPatch[tgtFaceI]; - // crude resultant norm vector n(-src.normal(srcPoints)); if (reverseTarget_) @@ -1900,7 +1901,7 @@ template<class Type, class CombineOp> void Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget ( const UList<Type>& fld, - const CombineOp& bop, + const CombineOp& cop, List<Type>& result ) const { @@ -1937,7 +1938,7 @@ void Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget forAll(faces, i) { - bop(result[faceI], faceI, work[faces[i]], weights[i]); + cop(result[faceI], faceI, work[faces[i]], weights[i]); } } } @@ -1950,7 +1951,7 @@ void Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget forAll(faces, i) { - bop(result[faceI], faceI, fld[faces[i]], weights[i]); + cop(result[faceI], faceI, fld[faces[i]], weights[i]); } } } @@ -1962,7 +1963,7 @@ template<class Type, class CombineOp> void Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource ( const UList<Type>& fld, - const CombineOp& bop, + const CombineOp& cop, List<Type>& result ) const { @@ -1999,7 +2000,7 @@ void Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource forAll(faces, i) { - bop(result[faceI], faceI, work[faces[i]], weights[i]); + cop(result[faceI], faceI, work[faces[i]], weights[i]); } } } @@ -2012,7 +2013,7 @@ void Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource forAll(faces, i) { - bop(result[faceI], faceI, fld[faces[i]], weights[i]); + cop(result[faceI], faceI, fld[faces[i]], weights[i]); } } } @@ -2020,12 +2021,12 @@ void Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource template<class SourcePatch, class TargetPatch> -template<class Type, class BinaryOp> +template<class Type, class CombineOp> Foam::tmp<Foam::Field<Type> > Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource ( const Field<Type>& fld, - const BinaryOp& bop + const CombineOp& cop ) const { tmp<Field<Type> > tresult @@ -2037,32 +2038,32 @@ Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource ) ); - interpolateToSource(fld, combineBinaryOp<Type, BinaryOp>(bop), tresult()); + interpolateToSource(fld, combineBinaryOp<Type, CombineOp>(cop), tresult()); return tresult; } template<class SourcePatch, class TargetPatch> -template<class Type, class BinaryOp> +template<class Type, class CombineOp> Foam::tmp<Foam::Field<Type> > Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource ( const tmp<Field<Type> >& tFld, - const BinaryOp& bop + const CombineOp& cop ) const { - return interpolateToSource(tFld(), bop); + return interpolateToSource(tFld(), cop); } template<class SourcePatch, class TargetPatch> -template<class Type, class BinaryOp> +template<class Type, class CombineOp> Foam::tmp<Foam::Field<Type> > Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget ( const Field<Type>& fld, - const BinaryOp& bop + const CombineOp& cop ) const { tmp<Field<Type> > tresult @@ -2074,22 +2075,22 @@ Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget ) ); - interpolateToTarget(fld, combineBinaryOp<Type, BinaryOp>(bop), tresult()); + interpolateToTarget(fld, combineBinaryOp<Type, CombineOp>(cop), tresult()); return tresult; } template<class SourcePatch, class TargetPatch> -template<class Type, class BinaryOp> +template<class Type, class CombineOp> Foam::tmp<Foam::Field<Type> > Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget ( const tmp<Field<Type> >& tFld, - const BinaryOp& bop + const CombineOp& cop ) const { - return interpolateToTarget(tFld(), bop); + return interpolateToTarget(tFld(), cop); } @@ -2101,7 +2102,7 @@ Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource const Field<Type>& fld ) const { - return interpolateToSource(fld, sumOp<Type>()); + return interpolateToSource(fld, plusEqOp<Type>()); } @@ -2113,7 +2114,7 @@ Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToSource const tmp<Field<Type> >& tFld ) const { - return interpolateToSource(tFld(), sumOp<Type>()); + return interpolateToSource(tFld(), plusEqOp<Type>()); } @@ -2125,7 +2126,7 @@ Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget const Field<Type>& fld ) const { - return interpolateToTarget(fld, sumOp<Type>()); + return interpolateToTarget(fld, plusEqOp<Type>()); } @@ -2137,7 +2138,7 @@ Foam::AMIInterpolation<SourcePatch, TargetPatch>::interpolateToTarget const tmp<Field<Type> >& tFld ) const { - return interpolateToTarget(tFld(), sumOp<Type>()); + return interpolateToTarget(tFld(), plusEqOp<Type>()); } diff --git a/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.H b/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.H index a342d65e3aeb0098d76bbdd7276b08949bf91d82..fe09d3759474a4823dfc094cd93d71e5d1783d7c 100644 --- a/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.H +++ b/src/meshTools/AMIInterpolation/AMIInterpolation/AMIInterpolation.H @@ -429,36 +429,36 @@ public: //- Interpolate from target to source with supplied binary op - template<class Type, class BinaryOp> + template<class Type, class CombineOp> tmp<Field<Type> > interpolateToSource ( const Field<Type>& fld, - const BinaryOp& bop + const CombineOp& cop ) const; //- Interpolate from target tmp field to source with supplied // binary op - template<class Type, class BinaryOp> + template<class Type, class CombineOp> tmp<Field<Type> > interpolateToSource ( const tmp<Field<Type> >& tFld, - const BinaryOp& bop + const CombineOp& cop ) const; //- Interpolate from source to target with supplied op - template<class Type, class BinaryOp> + template<class Type, class CombineOp> tmp<Field<Type> > interpolateToTarget ( const Field<Type>& fld, - const BinaryOp& bop + const CombineOp& cop ) const; //- Interpolate from source tmp field to target with supplied op - template<class Type, class BinaryOp> + template<class Type, class CombineOp> tmp<Field<Type> > interpolateToTarget ( const tmp<Field<Type> >& tFld, - const BinaryOp& bop + const CombineOp& cop ) const; //- Interpolate from target to source diff --git a/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.H b/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.H index 71afd2fba648eb9ef22beea8b3b1259e42e0a29f..f9afc00cdff0a4794cb837219361188a4d66e22e 100644 --- a/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.H +++ b/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBase.H @@ -376,16 +376,16 @@ public: void distribute(List<Type>& lst) const; //- Wrapper around map/interpolate data distribution with operation - template<class Type, class BinaryOp> - void distribute(List<Type>& lst, const BinaryOp& bop) const; + template<class Type, class CombineOp> + void distribute(List<Type>& lst, const CombineOp& cop) const; //- Wrapper around map/interpolate data distribution template<class Type> void reverseDistribute(List<Type>& lst) const; //- Wrapper around map/interpolate data distribution with operation - template<class Type, class BinaryOp> - void reverseDistribute(List<Type>& lst, const BinaryOp& bop) const; + template<class Type, class CombineOp> + void reverseDistribute(List<Type>& lst, const CombineOp& cop) const; // I/O diff --git a/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBaseTemplates.C b/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBaseTemplates.C index a4e36ff4575aff7806297c4596ff8454e2210c27..8b5a50e394dac7a59abeb9408bccf1e67fd8a834 100644 --- a/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBaseTemplates.C +++ b/src/meshTools/mappedPatches/mappedPolyPatch/mappedPatchBaseTemplates.C @@ -41,11 +41,11 @@ void Foam::mappedPatchBase::distribute(List<Type>& lst) const } -template<class Type, class BinaryOp> +template<class Type, class CombineOp> void Foam::mappedPatchBase::distribute ( List<Type>& lst, - const BinaryOp& bop + const CombineOp& cop ) const { switch (mode_) @@ -55,7 +55,7 @@ void Foam::mappedPatchBase::distribute lst = AMI().interpolateToSource ( Field<Type>(lst.xfer()), - bop + cop ); break; } @@ -69,7 +69,7 @@ void Foam::mappedPatchBase::distribute map().subMap(), map().constructMap(), lst, - bop, + cop, pTraits<Type>::zero ); } @@ -96,11 +96,11 @@ void Foam::mappedPatchBase::reverseDistribute(List<Type>& lst) const } -template<class Type, class BinaryOp> +template<class Type, class CombineOp> void Foam::mappedPatchBase::reverseDistribute ( List<Type>& lst, - const BinaryOp& bop + const CombineOp& cop ) const { switch (mode_) @@ -110,7 +110,7 @@ void Foam::mappedPatchBase::reverseDistribute lst = AMI().interpolateToTarget ( Field<Type>(lst.xfer()), - bop + cop ); break; } @@ -125,7 +125,7 @@ void Foam::mappedPatchBase::reverseDistribute map().constructMap(), map().subMap(), lst, - bop, + cop, pTraits<Type>::zero ); break; diff --git a/src/meshTools/sets/topoSets/topoSet.C b/src/meshTools/sets/topoSets/topoSet.C index 75d674e306cbb34ac466d100c82ba12d4b97149e..561d9fbe46c3958de7ef911258ce58f0fd7b30bf 100644 --- a/src/meshTools/sets/topoSets/topoSet.C +++ b/src/meshTools/sets/topoSets/topoSet.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -135,7 +135,7 @@ Foam::fileName Foam::topoSet::topoSet::localPath const word& name ) { - return mesh.facesInstance()/polyMesh::meshSubDir/"sets"/name; + return mesh.facesInstance()/mesh.dbDir()/polyMesh::meshSubDir/"sets"/name; } diff --git a/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C b/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C index 5a9e4b1d1e121fefdbd58b8504abb8ab767caca7..608cddbc73e5637ef081c29582f88d0009f0789b 100644 --- a/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C +++ b/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C @@ -157,9 +157,22 @@ void Foam::fieldMinMax::writeFileHeader() { fieldMinMaxFilePtr_() << "# Time" << token::TAB << "field" << token::TAB - << "min" << token::TAB << "position(min)" << token::TAB - << "max" << token::TAB << "position(max)" << token::TAB - << endl; + << "min" << token::TAB << "position(min)"; + + if (Pstream::parRun()) + { + fieldMinMaxFilePtr_() << token::TAB << "proc"; + } + + fieldMinMaxFilePtr_() + << token::TAB << "max" << token::TAB << "position(max)"; + + if (Pstream::parRun()) + { + fieldMinMaxFilePtr_() << token::TAB << "proc"; + } + + fieldMinMaxFilePtr_() << endl; } } diff --git a/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMaxTemplates.C b/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMaxTemplates.C index c2e96743297ceb91b6a6aafa6e97b204e679a45a..d014ecd0a6a3f599e24d491964f2aef21d12a643 100644 --- a/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMaxTemplates.C +++ b/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMaxTemplates.C @@ -88,16 +88,43 @@ void Foam::fieldMinMax::calcMinMaxFields fieldMinMaxFilePtr_() << obr_.time().value() << token::TAB << fieldName << token::TAB - << minValue << token::TAB << minC << token::TAB - << maxValue << token::TAB << maxC << endl; + << minValue << token::TAB << minC; + + if (Pstream::parRun()) + { + fieldMinMaxFilePtr_() << token::TAB << minI; + } + + fieldMinMaxFilePtr_() + << token::TAB << maxValue << token::TAB << maxC; + + if (Pstream::parRun()) + { + fieldMinMaxFilePtr_() << token::TAB << maxI; + } + + fieldMinMaxFilePtr_() << endl; } if (log_) { Info<< " min(mag(" << fieldName << ")) = " - << minValue << " at position " << minC << nl - << " max(mag(" << fieldName << ")) = " - << maxValue << " at position " << maxC << nl; + << minValue << " at position " << minC; + + if (Pstream::parRun()) + { + Info<< " on processor " << minI; + } + + Info<< nl << " max(mag(" << fieldName << ")) = " + << maxValue << " at position " << maxC; + + if (Pstream::parRun()) + { + Info<< " on processor " << maxI; + } + + Info<< endl; } } break; @@ -142,16 +169,43 @@ void Foam::fieldMinMax::calcMinMaxFields fieldMinMaxFilePtr_() << obr_.time().value() << token::TAB << fieldName << token::TAB - << minValue << token::TAB << minC << token::TAB - << maxValue << token::TAB << maxC << endl; + << minValue << token::TAB << minC; + + if (Pstream::parRun()) + { + fieldMinMaxFilePtr_() << token::TAB << minI; + } + + fieldMinMaxFilePtr_() + << token::TAB << maxValue << token::TAB << maxC; + + if (Pstream::parRun()) + { + fieldMinMaxFilePtr_() << token::TAB << maxI; + } + + fieldMinMaxFilePtr_() << endl; } if (log_) { Info<< " min(" << fieldName << ") = " - << minValue << " at position " << minC << nl - << " max(" << fieldName << ") = " - << maxValue << " at position " << maxC << nl; + << minValue << " at position " << minC; + + if (Pstream::parRun()) + { + Info<< " on processor " << minI; + } + + Info<< nl << " max(" << fieldName << ") = " + << maxValue << " at position " << maxC; + + if (Pstream::parRun()) + { + Info<< " on processor " << maxI; + } + + Info<< endl; } } break; diff --git a/src/regionModels/regionModel/regionModel/regionModel.H b/src/regionModels/regionModel/regionModel/regionModel.H index f8444d6cec1eca6f4477bf63ac328fcce6c90831..b65b3a23c7ed5cdc06772f5626f16d3b2a5a7338 100644 --- a/src/regionModels/regionModel/regionModel/regionModel.H +++ b/src/regionModels/regionModel/regionModel/regionModel.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -117,6 +117,7 @@ protected: //- List of patch IDs internally coupled with the primary region labelList intCoupledPatchIDs_; + //- Region name word regionName_; @@ -235,21 +236,21 @@ public: ) const; //- Convert a local region field to the primary region with op - template<class Type, class BinaryOp> + template<class Type, class CombineOp> void toPrimary ( const label regionPatchI, List<Type>& regionField, - const BinaryOp& bop + const CombineOp& cop ) const; //- Convert a primary region field to the local region with op - template<class Type, class BinaryOp> + template<class Type, class CombineOp> void toRegion ( const label regionPatchI, List<Type>& primaryFieldField, - const BinaryOp& bop + const CombineOp& cop ) const; diff --git a/src/regionModels/regionModel/regionModel/regionModelTemplates.C b/src/regionModels/regionModel/regionModel/regionModelTemplates.C index ab013ad8e08f09cff6df2b8142805c7605813b5f..b78772de017f34dd966b8e6df1be4bab0a9490ce 100644 --- a/src/regionModels/regionModel/regionModel/regionModelTemplates.C +++ b/src/regionModels/regionModel/regionModel/regionModelTemplates.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,12 +77,12 @@ void Foam::regionModels::regionModel::toRegion } -template<class Type, class BinaryOp> +template<class Type, class CombineOp> void Foam::regionModels::regionModel::toPrimary ( const label regionPatchI, List<Type>& regionField, - const BinaryOp& bop + const CombineOp& cop ) const { forAll(intCoupledPatchIDs_, i) @@ -94,7 +94,7 @@ void Foam::regionModels::regionModel::toPrimary ( regionMesh().boundaryMesh()[regionPatchI] ); - mpb.reverseDistribute(regionField, bop); + mpb.reverseDistribute(regionField, cop); return; } } @@ -105,19 +105,19 @@ void Foam::regionModels::regionModel::toPrimary "(" "const label, " "List<Type>&, " - "const BinaryOp&" + "const CombineOp&" ") const" ) << "Region patch ID " << regionPatchI << " not found in region mesh" << abort(FatalError); } -template<class Type, class BinaryOp> +template<class Type, class CombineOp> void Foam::regionModels::regionModel::toRegion ( const label regionPatchI, List<Type>& primaryField, - const BinaryOp& bop + const CombineOp& cop ) const { forAll(intCoupledPatchIDs_, i) @@ -129,14 +129,14 @@ void Foam::regionModels::regionModel::toRegion ( regionMesh().boundaryMesh()[regionPatchI] ); - mpb.distribute(primaryField, bop); + mpb.distribute(primaryField, cop); return; } } FatalErrorIn ( - "const void toRegion(const label, List<Type>&, const BinaryOp&) const" + "const void toRegion(const label, List<Type>&, const CombineOp&) const" ) << "Region patch ID " << regionPatchI << " not found in region mesh" << abort(FatalError); } diff --git a/src/regionModels/surfaceFilmModels/kinematicSingleLayer/kinematicSingleLayer.C b/src/regionModels/surfaceFilmModels/kinematicSingleLayer/kinematicSingleLayer.C index a448083f997ce136619e8e4bfab473af3ef6629d..86f5b34b63e550dac6fe049fc115522262d87433 100644 --- a/src/regionModels/surfaceFilmModels/kinematicSingleLayer/kinematicSingleLayer.C +++ b/src/regionModels/surfaceFilmModels/kinematicSingleLayer/kinematicSingleLayer.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -879,22 +879,19 @@ scalar kinematicSingleLayer::CourantNumber() const if (regionMesh().nInternalFaces() > 0) { - const scalar deltaT = time_.deltaTValue(); + const scalarField sumPhi(fvc::surfaceSum(mag(phi_))); - const surfaceScalarField SfUfbyDelta - ( - regionMesh().surfaceInterpolation::deltaCoeffs()*mag(phi_) - ); - const surfaceScalarField rhoDelta(fvc::interpolate(rho_*delta_)); - const surfaceScalarField& magSf = regionMesh().magSf(); + const scalarField& V = regionMesh().V(); - forAll(rhoDelta, i) + forAll(deltaRho_, i) { - if (rhoDelta[i] > ROOTVSMALL) + if (deltaRho_[i] > SMALL) { - CoNum = max(CoNum, SfUfbyDelta[i]/rhoDelta[i]/magSf[i]*deltaT); + CoNum = max(CoNum, sumPhi[i]/deltaRho_[i]/V[i]); } } + + CoNum *= 0.5*time_.deltaTValue(); } reduce(CoNum, maxOp<scalar>()); diff --git a/src/thermophysicalModels/basic/Make/files b/src/thermophysicalModels/basic/Make/files index 1c08f455dfd1f1231e23ddf8d4b1835b2cec8fb9..ba53ed77405176ae3cfacce07456807bcf6dfbb3 100644 --- a/src/thermophysicalModels/basic/Make/files +++ b/src/thermophysicalModels/basic/Make/files @@ -22,6 +22,7 @@ derivedFvPatchFields/mixedEnthalpy/mixedEnthalpyFvPatchScalarField.C derivedFvPatchFields/fixedInternalEnergy/fixedInternalEnergyFvPatchScalarField.C derivedFvPatchFields/gradientInternalEnergy/gradientInternalEnergyFvPatchScalarField.C derivedFvPatchFields/mixedInternalEnergy/mixedInternalEnergyFvPatchScalarField.C +derivedFvPatchFields/enthalpyJump/enthalpyJumpFvPatchScalarField.C derivedFvPatchFields/wallHeatTransfer/wallHeatTransferFvPatchScalarField.C diff --git a/src/thermophysicalModels/basic/Make/options b/src/thermophysicalModels/basic/Make/options index 8b8c0733d056383ffe992b66fee93fc3ba6a028b..4eba2f1e115c0d5d02742c6473cf95391bf8410c 100644 --- a/src/thermophysicalModels/basic/Make/options +++ b/src/thermophysicalModels/basic/Make/options @@ -1,6 +1,8 @@ EXE_INC = \ -I$(LIB_SRC)/finiteVolume/lnInclude \ - -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude + -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \ + -I/home/tom3/sergio/development/chtMultiRegionCoupledFoam/lnInclude LIB_LIBS = \ - -lfiniteVolume + -lfiniteVolume \ + -L$(FOAM_USER_LIBBIN)/FvPatchScalarFieldEnthalpyJump diff --git a/src/thermophysicalModels/basic/basicThermo/basicThermo.C b/src/thermophysicalModels/basic/basicThermo/basicThermo.C index 59c00560407c1f35fba58930b69ded28f8261ad6..bb6acc01ed2ab34b02d30be378a273e114be5b00 100644 --- a/src/thermophysicalModels/basic/basicThermo/basicThermo.C +++ b/src/thermophysicalModels/basic/basicThermo/basicThermo.C @@ -33,6 +33,8 @@ License #include "fixedInternalEnergyFvPatchScalarField.H" #include "gradientInternalEnergyFvPatchScalarField.H" #include "mixedInternalEnergyFvPatchScalarField.H" +#include "temperatureJumpFvPatchScalarField.H" +#include "enthalpyJumpFvPatchScalarField.H" /* * * * * * * * * * * * * * * private static data * * * * * * * * * * * * * */ @@ -64,10 +66,14 @@ Foam::wordList Foam::basicThermo::hBoundaryTypes() { hbt[patchi] = gradientEnthalpyFvPatchScalarField::typeName; } - else if (isA<mixedFvPatchScalarField>(tbf[patchi])) + else if(isA<mixedFvPatchScalarField>(tbf[patchi])) { hbt[patchi] = mixedEnthalpyFvPatchScalarField::typeName; } + else if (isA<temperatureJumpFvPatchScalarField>(tbf[patchi])) + { + hbt[patchi] = enthalpyJumpFvPatchScalarField::typeName; + } } return hbt; @@ -85,7 +91,7 @@ void Foam::basicThermo::hBoundaryCorrection(volScalarField& h) refCast<gradientEnthalpyFvPatchScalarField>(hbf[patchi]).gradient() = hbf[patchi].fvPatchField::snGrad(); } - else if (isA<mixedEnthalpyFvPatchScalarField>(hbf[patchi])) + else if(isA<mixedEnthalpyFvPatchScalarField>(hbf[patchi])) { refCast<mixedEnthalpyFvPatchScalarField>(hbf[patchi]).refGrad() = hbf[patchi].fvPatchField::snGrad(); diff --git a/src/thermophysicalModels/basic/derivedFvPatchFields/enthalpyJump/enthalpyJumpFvPatchScalarField.C b/src/thermophysicalModels/basic/derivedFvPatchFields/enthalpyJump/enthalpyJumpFvPatchScalarField.C new file mode 100644 index 0000000000000000000000000000000000000000..4337dd2ffb9c8e1f20b4fef88bfdc6d594634f2d --- /dev/null +++ b/src/thermophysicalModels/basic/derivedFvPatchFields/enthalpyJump/enthalpyJumpFvPatchScalarField.C @@ -0,0 +1,165 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation + \\/ 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 "addToRunTimeSelectionTable.H" +#include "enthalpyJumpFvPatchScalarField.H" +#include "temperatureJumpFvPatchScalarField.H" +#include "basicThermo.H" + +// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // + +Foam::enthalpyJumpFvPatchScalarField::enthalpyJumpFvPatchScalarField +( + const fvPatch& p, + const DimensionedField<scalar, volMesh>& iF +) +: + fixedJumpFvPatchField<scalar>(p, iF) +{} + + +Foam::enthalpyJumpFvPatchScalarField::enthalpyJumpFvPatchScalarField +( + const enthalpyJumpFvPatchScalarField& ptf, + const fvPatch& p, + const DimensionedField<scalar, volMesh>& iF, + const fvPatchFieldMapper& mapper +) +: + fixedJumpFvPatchField<scalar>(ptf, p, iF, mapper) +{} + + +Foam::enthalpyJumpFvPatchScalarField::enthalpyJumpFvPatchScalarField +( + const fvPatch& p, + const DimensionedField<scalar, volMesh>& iF, + const dictionary& dict +) +: + fixedJumpFvPatchField<scalar>(p, iF) +{ + + if (dict.found("value")) + { + fvPatchScalarField::operator= + ( + scalarField("value", dict, p.size()) + ); + } +} + + +Foam::enthalpyJumpFvPatchScalarField::enthalpyJumpFvPatchScalarField +( + const enthalpyJumpFvPatchScalarField& ptf +) +: + cyclicLduInterfaceField(), + fixedJumpFvPatchField<scalar>(ptf) +{} + + +Foam::enthalpyJumpFvPatchScalarField::enthalpyJumpFvPatchScalarField +( + const enthalpyJumpFvPatchScalarField& ptf, + const DimensionedField<scalar, volMesh>& iF +) +: + fixedJumpFvPatchField<scalar>(ptf, iF) +{} + + +// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // + +void Foam::enthalpyJumpFvPatchScalarField::updateCoeffs() +{ + if (this->updated()) + { + return; + } + + if (this->cyclicPatch().owner()) + { + const basicThermo& thermo = db().lookupObject<basicThermo> + ( + "thermophysicalProperties" + ); + + label patchID = patch().index(); + + const temperatureJumpFvPatchScalarField& TbPatch = + refCast<const temperatureJumpFvPatchScalarField> + ( + thermo.T().boundaryField()[patchID] + ); + + const scalar time = this->db().time().value(); + const scalarField jumpTb + ( + patch().size(), TbPatch.jumpTable().value(time) + ); + + const labelUList& faceCells = this->patch().faceCells(); + + if (db().foundObject<volScalarField>("h")) + { + jump_ = thermo.h(jumpTb, faceCells); + } + else if (db().foundObject<volScalarField>("hs")) + { + jump_ = thermo.hs(jumpTb, faceCells); + } + else + { + FatalErrorIn("enthalpyJumpFvPatchScalarField::updateCoeffs()") + << " hs or h are not found in db()" + << exit(FatalError); + } + } + + fixedJumpFvPatchField<scalar>::updateCoeffs(); +} + + +void Foam::enthalpyJumpFvPatchScalarField::write(Ostream& os) const +{ + fixedJumpFvPatchField<scalar>::write(os); + this->writeEntry("value", os); +} + + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + makePatchTypeField + ( + fvPatchScalarField, + enthalpyJumpFvPatchScalarField + ); +} + +// ************************************************************************* // diff --git a/src/thermophysicalModels/basic/derivedFvPatchFields/enthalpyJump/enthalpyJumpFvPatchScalarField.H b/src/thermophysicalModels/basic/derivedFvPatchFields/enthalpyJump/enthalpyJumpFvPatchScalarField.H new file mode 100644 index 0000000000000000000000000000000000000000..770e2a473949d86e5391c4c7c832389d5182be0d --- /dev/null +++ b/src/thermophysicalModels/basic/derivedFvPatchFields/enthalpyJump/enthalpyJumpFvPatchScalarField.H @@ -0,0 +1,142 @@ +/*---------------------------------------------------------------------------*\ + ========= | + \\ / F ield | OpenFOAM: The Open Source CFD Toolbox + \\ / O peration | + \\ / A nd | Copyright (C) 2012 OpenFOAM Foundation + \\/ 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/>. + +Class + Foam::enthalpyJumpFvPatchScalarField + +Description + +SourceFiles + enthalpyJumpFvPatchScalarField.C + +\*---------------------------------------------------------------------------*/ + +#ifndef enthalpyJumpFvPatchScalarField_H +#define enthalpyJumpFvPatchScalarField_H + +#include "fixedJumpFvPatchField.H" +#include "DataEntry.H" + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +namespace Foam +{ + +/*---------------------------------------------------------------------------*\ + Class enthalpyJumpFvPatchScalarField Declaration +\*---------------------------------------------------------------------------*/ + +class enthalpyJumpFvPatchScalarField +: + public fixedJumpFvPatchField<scalar> +{ + +public: + + //- Runtime type information + TypeName("enthalpyJump"); + + // Constructors + + //- Construct from patch and internal field + enthalpyJumpFvPatchScalarField + ( + const fvPatch&, + const DimensionedField<scalar, volMesh>& + ); + + //- Construct from patch, internal field and dictionary + enthalpyJumpFvPatchScalarField + ( + const fvPatch&, + const DimensionedField<scalar, volMesh>&, + const dictionary& + ); + + //- Construct by mapping given enthalpyJumpFvPatchScalarField onto a + // new patch + enthalpyJumpFvPatchScalarField + ( + const enthalpyJumpFvPatchScalarField&, + const fvPatch&, + const DimensionedField<scalar, volMesh>&, + const fvPatchFieldMapper& + ); + + //- Construct as copy + enthalpyJumpFvPatchScalarField + ( + const enthalpyJumpFvPatchScalarField& + ); + + //- Construct and return a clone + virtual tmp<fvPatchField<scalar> > clone() const + { + return tmp<fvPatchField<scalar> > + ( + new enthalpyJumpFvPatchScalarField(*this) + ); + } + + //- Construct as copy setting internal field reference + enthalpyJumpFvPatchScalarField + ( + const enthalpyJumpFvPatchScalarField&, + const DimensionedField<scalar, volMesh>& + ); + + //- Construct and return a clone setting internal field reference + virtual tmp<fvPatchField<scalar> > clone + ( + const DimensionedField<scalar, volMesh>& iF + ) const + { + return tmp<fvPatchField<scalar> > + ( + new enthalpyJumpFvPatchScalarField(*this, iF) + ); + } + + + // Member functions + + + // Evaluation functions + + //- Update the coefficients + virtual void updateCoeffs(); + + + //- Write + virtual void write(Ostream&) const; +}; + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +} // End namespace Foam + +// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // + +#endif + +// ************************************************************************* // diff --git a/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C b/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C index 7f4d0fe1887fd55d1da3c260c10346443f93b8e8..92604068408029540f631cc1216f6fc8bd0d6f68 100644 --- a/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C +++ b/src/thermophysicalModels/basic/psiThermo/hPsiThermo/hPsiThermo.C @@ -113,7 +113,8 @@ Foam::hPsiThermo<MixtureType>::hPsiThermo(const fvMesh& mesh) ), mesh, dimEnergy/dimMass, - this->hBoundaryTypes() + this->hBoundaryTypes(), + mesh.boundaryMesh().types() ) { scalarField& hCells = h_.internalField(); diff --git a/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C b/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C index a8010f8700f2721bd80c86a9843db5ed7c8ee429..7d1cae28f9715b44e38904cb421e051ad1d00ea0 100644 --- a/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C +++ b/src/thermophysicalModels/basic/psiThermo/hsPsiThermo/hsPsiThermo.C @@ -113,7 +113,8 @@ Foam::hsPsiThermo<MixtureType>::hsPsiThermo(const fvMesh& mesh) ), mesh, dimEnergy/dimMass, - this->hBoundaryTypes() + this->hBoundaryTypes(), + mesh.boundaryMesh().types() ) { scalarField& hsCells = hs_.internalField(); diff --git a/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C b/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C index e2e7503cfc938a1681a55fdf12940d02ad7f3044..d27b7b31cd9b4c1c81bfb01f2832f3db6692358c 100644 --- a/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C +++ b/src/thermophysicalModels/basic/rhoThermo/hRhoThermo/hRhoThermo.C @@ -118,9 +118,11 @@ Foam::hRhoThermo<MixtureType>::hRhoThermo(const fvMesh& mesh) ), mesh, dimEnergy/dimMass, - this->hBoundaryTypes() + this->hBoundaryTypes(), + mesh.boundaryMesh().types() ) { + scalarField& hCells = h_.internalField(); const scalarField& TCells = this->T_.internalField(); @@ -138,6 +140,7 @@ Foam::hRhoThermo<MixtureType>::hRhoThermo(const fvMesh& mesh) hBoundaryCorrection(h_); calculate(); + } diff --git a/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C b/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C index f8697bf675beabbcb7d650d392dd17a33bbac7f4..8d55e26d93d05a476305d5e1481381b01287bb64 100644 --- a/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C +++ b/src/thermophysicalModels/basic/rhoThermo/hsRhoThermo/hsRhoThermo.C @@ -118,7 +118,8 @@ Foam::hsRhoThermo<MixtureType>::hsRhoThermo(const fvMesh& mesh) ), mesh, dimEnergy/dimMass, - this->hBoundaryTypes() + this->hBoundaryTypes(), + mesh.boundaryMesh().types() ) { scalarField& hsCells = hs_.internalField();