Functions | Variables
readKivaGrid.H File Reference
Include dependency graph for readKivaGrid.H:

Go to the source code of this file.

Functions

ifstream kivaFile (kivaFileName.c_str())
 
 if (!kivaFile.good())
 
pointField points (nPoints)
 
labelList idface (nPoints)
 
labelList fv (nPoints)
 
 for (label i=0;i< nPoints;i++)
 
labelList i1tab (nPoints)
 
labelList i3tab (nPoints)
 
labelList i8tab (nPoints)
 
labelList idreg (nPoints)
 
labelList f (nPoints)
 
labelList bcl (nPoints)
 
labelList bcf (nPoints)
 
labelList bcb (nPoints)
 
 if (mTable==0)
 
labelList imtab (nPoints)
 
labelList jmtab (nPoints)
 
labelList kmtab (nPoints)
 
face quadFace (4)
 
face triFace (3)
 
 if (pFaces[LINER].size() &&pFaces[LINER][0].size() &&pFaces[CYLINDERHEAD].size() &&pFaces[CYLINDERHEAD][0].size())
 
 if (pFaces[WEDGE].size() &&pFaces[WEDGE][0].size())
 
faceListList boundary (nPatches)
 
wordList patchNames (nPatches)
 
wordList patchTypes (nPatches)
 
labelList pointLabels (nPoints, -1)
 
 forAll (cellShapes, celli)
 
 forAll (pointLabels, pointi)
 
points setSize (newPointi)
 
 forAll (boundary, patchi)
 
 preservePatchTypes (runTime, runTime.constant(), polyMesh::meshSubDir, patchNames, patchDicts, defaultFacesName, defaultFacesType)
 
 forAll (patchNames, patchI)
 
polyMesh pShapeMesh (IOobject(polyMesh::defaultRegion, runTime.constant(), runTime), xferMove(points), cellShapes, boundary, patchNames, patchDicts, defaultFacesName, defaultFacesType)
 

Variables

Info<< "Reading kiva grid from file "<< kivaFileName<< endl;char title[120];kivaFile.getline(title, 120, '\n');label nPoints, nCells, nRegs;kivaFile > nCells nPoints nRegs
 
label i4
 
label nBfaces = 0
 
label mTable
 
Info<< "Finished reading KIVA file"<< endl;cellShapeList cellShapes(nPoints);labelList cellZoning(nPoints, -1);const cellModel &hex=*(cellModeller::lookup("hex"));labelList hexLabels(8);label activeCells=0;labelList pointMap(nPoints);forAll(pointMap, i){ pointMap[i]=i;}for(label i=0;i< nPoints;i++){ if(f[i] > 0.0) { hexLabels[0]=i;hexLabels[1]=i1tab[i];hexLabels[2]=i3tab[i1tab[i]];hexLabels[3]=i3tab[i];hexLabels[4]=i8tab[i];hexLabels[5]=i1tab[i8tab[i]];hexLabels[6]=i3tab[i1tab[i8tab[i]]];hexLabels[7]=i3tab[i8tab[i]];cellShapes[activeCells]=cellShape(hex, hexLabels);edgeList edges=cellShapes[activeCells].edges();forAll(edges, ei) { if(edges[ei].mag(points)< SMALL) { label start=pointMap[edges[ei].start()];while(start !=pointMap[start]) { start=pointMap[start];} label end=pointMap[edges[ei].end()];while(end !=pointMap[end]) { end=pointMap[end];} label minLabel=min(start, end);pointMap[start]=pointMap[end]=minLabel;} } cellZoning[activeCells]=idreg[i];activeCells++;}}cellShapes.setSize(activeCells);cellZoning.setSize(activeCells);forAll(cellShapes, celli){ cellShape &cs=cellShapes[celli];forAll(cs, i) { cs[i]=pointMap[cs[i]];} cs.collapse();}label bcIDs[11]={-1, 0, 2, 4, -1, 5, -1, 6, 7, 8, 9};const label nBCs=12;const word *kivaPatchTypes[nBCs]={ &wallPolyPatch::typeName, &wallPolyPatch::typeName, &wallPolyPatch::typeName, &wallPolyPatch::typeName, &symmetryPolyPatch::typeName, &wedgePolyPatch::typeName, &polyPatch::typeName, &polyPatch::typeName, &polyPatch::typeName, &polyPatch::typeName, &symmetryPolyPatch::typeName, &oldCyclicPolyPatch::typeName};enum patchTypeNames{ PISTON, VALVE, LINER, CYLINDERHEAD, AXIS, WEDGE, INFLOW, OUTFLOW, PRESIN, PRESOUT, SYMMETRYPLANE, CYCLIC};const char *kivaPatchNames[nBCs]={ "piston", "valve", "liner", "cylinderHead", "axis", "wedge", "inflow", "outflow", "presin", "presout", "symmetryPlane", "cyclic"};List< SLList< face > > pFaces [nBCs]
 
label nPatches = 0
 
word defaultFacesName = "defaultFaces"
 
word defaultFacesType = emptyPolyPatch::typeName
 
label nAddedPatches = 0
 
label newPointi = 0
 
PtrList< dictionary > patchDicts
 

Function Documentation

◆ kivaFile()

ifstream kivaFile ( kivaFileName.  c_str())

Referenced by for().

Here is the caller graph for this function:

◆ if() [1/4]

if ( !kivaFile.  good())

Definition at line 3 of file readKivaGrid.H.

References Foam::exit(), Foam::FatalError, and FatalErrorInFunction.

Here is the call graph for this function:

◆ points()

pointField points ( nPoints  )

Referenced by for(), forAll(), and if().

Here is the caller graph for this function:

◆ idface()

labelList idface ( nPoints  )

Referenced by for(), and if().

Here is the caller graph for this function:

◆ fv()

labelList fv ( nPoints  )

◆ for()

for ( )

Definition at line 23 of file readKivaGrid.H.

References fv(), i4, idface(), kivaFile(), and points().

Here is the call graph for this function:

◆ i1tab()

labelList i1tab ( nPoints  )

◆ i3tab()

labelList i3tab ( nPoints  )

◆ i8tab()

labelList i8tab ( nPoints  )

◆ idreg()

labelList idreg ( nPoints  )

◆ f()

labelList f ( nPoints  )

Referenced by isoSurface::adaptPatchFields(), multivariateSurfaceInterpolationScheme< Type >::fieldTable::add(), singleProcessorFaceSetsConstraint::add(), polyMeshGenModifier::addBufferCells(), polyMeshGenModifierAddCellByCell::addCell(), polyMeshGenModifier::addCell(), polyMeshGenModifier::addCells(), boundaryCutter::addEdgeCutsToFace(), meshCutAndRemove::addEdgeCutsToFace(), meshCutter::addEdgeCutsToFace(), tetDecomposer::addFace(), polyTopoChange::addFace(), geometrySurface::addGeometryToScene(), autoLayerDriver::addLayers(), polyMeshGenModifier::addProcessorFaces(), globalPoints::addToSend(), addPatchCellLayer::addVertex(), singleCellFvMesh::agglomerateMesh(), faceListPMG::append(), singleProcessorFaceSetsConstraint::apply(), fvPatchField< Type >::autoMap(), Foam::average(), autoLayerDriver::avgPointData(), autoSnapDriver::avoidDiagonalAttraction(), booleanSurface::booleanSurface(), primitiveMeshTools::boundaryFaceSkewness(), searchableBox::boundingSpheres(), triSurfaceMesh::boundingSpheres(), InteractionLists< typename CloudType::parcelType >::buildInteractionLists(), cellCuts::calcAnchors(), treeDataPrimitivePatch< PatchType >::calcBb(), treeDataFace::calcBb(), volPointInterpolation::calcBoundaryAddressing(), PatchTools::calcBounds(), treeDataCell::calcCellBb(), polyMeshGenAddressing::calcCellPoints(), BrownianMotionForce< CloudType >::calcCoupled(), calcCurvature(), isoSurfaceCell::calcCutType(), isoSurface::calcCutTypes(), polyDualMesh::calcDual(), cellMatcher::calcEdgeAddressing(), polyMeshGenAddressing::calcEdgeFaces(), triSurface::calcEdgeOwner(), faceTriangulation::calcEdges(), primitiveMesh::calcEdges(), polyMeshGenAddressing::calcEdges(), cellCuts::calcFaceCuts(), polyMeshGenAddressing::calcFaceEdges(), coupledPolyPatch::calcFaceTol(), faceZone::calcFaceZonePatch(), meshSurfaceEngine::calcGlobalBoundaryEdgeLabels(), meshSurfaceEngine::calcGlobalBoundaryPointLabels(), polyMeshGenAddressing::calcGlobalEdgeLabels(), polyMeshGenAddressing::calcGlobalPointLabels(), triSurfaceTools::calcInterpolationWeights(), enrichedPatch::calcLocalFaces(), cellMatcher::calcLocalFaces(), ensightPartFaces::calcLocalPoints(), ensightPartCells::calcLocalPoints(), mixerFvMesh::calcMovingMasks(), autoSnapDriver::calcNearestFacePointProperties(), autoSnapDriver::calcNearestSurfaceFeature(), globalMeshData::calcPointBoundaryFaces(), meshReader::calcPointCells(), cellMatcher::calcPointFaceIndex(), PrimitivePatch< labelledTri, List, pointField, point >::calcPointFaces(), primitiveMesh::calcPointOrder(), polyMeshGenAddressing::calcPointPoints(), localPointRegion::calcPointRegions(), createShellMesh::calcPointRegions(), meshToMesh::calcProcMap(), isoSurfaceCell::calcSnappedCc(), isoSurface::calcSnappedCc(), isoSurfaceCell::calcSnappedPoint(), isoSurface::calcSnappedPoint(), triSurface::calcSortedEdgeFaces(), thresholdCellFaces::calculate(), rotorDiskSource::calculate(), meshSurfaceEngine::calculateBoundaryNodes(), meshSurfaceEngine::calculateEdgesAndAddressing(), boundaryLayerOptimisation::calculateHairEdges(), autoLayerDriver::calculateLayerThickness(), edgeExtractor::calculateSingleCellEdge(), boundaryLayerOptimisation::calculateThicknessOverCell(), nutUSpaldingWallFunctionFvPatchScalarField::calcUTau(), calcVertexNormals(), calcVertexNormalWeight(), pointMVCWeight::calcWeights(), cellMatcher::cellMatcher(), primitiveMesh::cellPoints(), cell::centre(), repatchPolyTopoChanger::changeAnchorPoint(), checkIrregularSurfaceConnections::checkAndFixCellGroupsAtBndVertices(), Foam::polyMeshGenChecks::checkCellPartTetrahedra(), Foam::polyMeshGenChecks::checkCellsZipUp(), primitiveMesh::checkCellsZipUp(), edgeExtractor::checkConcaveEdgeCells(), Foam::checkCoupledPoints(), polyMesh::checkEdgeAlignment(), primitiveMesh::checkEdgeAlignment(), checkIrregularSurfaceConnections::checkEdgeFaceConnections(), primitiveMesh::checkEdgeLength(), polyTopoChange::checkFace(), primitiveMeshGeometry::checkFaceAngles(), polyMeshGeometry::checkFaceAngles(), primitiveMesh::checkFaceAngles(), Foam::polyMeshGenChecks::checkFaceAngles(), checkFaceEdges(), polyMeshGeometry::checkFaceFlatness(), primitiveMesh::checkFaceFlatness(), Foam::polyMeshGenChecks::checkFaceFlatness(), primitiveMeshGeometry::checkFacePyramids(), polyMeshGeometry::checkFacePyramids(), primitiveMesh::checkFacePyramids(), MeshedSurface< Foam::face >::checkFaces(), primitiveMesh::checkFaceSkewness(), polyMeshGeometry::checkFaceTet(), polyMeshTetDecomposition::checkFaceTets(), primitiveMeshGeometry::checkFaceTwist(), polyMeshGeometry::checkFaceTwist(), primitiveMesh::checkFaceVertices(), regIOobject::checkIn(), topologicalCleaner::checkInvalidConnectionsForVerticesCells(), hexRef8::checkMesh(), polyMeshFilter::checkMeshFacesAndRelaxEdges(), primitiveMesh::checkMeshMotion(), edgeCollapser::checkMeshQuality(), topologicalCleaner::checkNonConsecutiveBoundaryVertices(), topologicalCleaner::checkNonMappableFaces(), PatchTools::checkOrientation(), searchableSurfaces::checkQuality(), Foam::checkTopology(), triSurface::checkTriangles(), polyMeshGeometry::checkTriangleTwist(), triSurfaceSearch::checkUniqueHit(), Foam::checkWedges(), ensightPartFaces::classify(), Foam::cmptAv(), Foam::cmptMag(), Foam::cmptMax(), Foam::cmptMin(), cellShape::collapsedFaces(), triSurfaceTools::collapseEdges(), edgeCollapser::collapseFace(), edgeCollapser::collapseToPoint(), meshBndLayerNeighbourOperator::collectGroups(), hexRef8::collectLevelPoints(), ORourkeCollision< CloudType >::collideSorted(), cellToPoint::combine(), faceToPoint::combine(), pointToCell::combine(), rotatedBoxToCell::combine(), pointToFace::combine(), faceSource::combineMeshGeometry(), polyTopoChange::compact(), Foam::component(), processorLduInterface::compressedReceive(), processorLduInterface::compressedSend(), edgeCollapser::consistentCollapse(), triSurface::convertToTri(), combineFaces::convexFace(), meshCutAndRemove::copyFace(), meshCutter::copyFace(), inversePointDistanceDiffusivity::correct(), meshStructure::correct(), pointLinear< Type >::correction(), CentredFitScheme< Type, Polynomial, Stencil >::correction(), hexRef8::countAnchors(), edgeCollapser::countEdgesOnFace(), cellCuts::countFaceCuts(), localPointRegion::countPointRegions(), removePoints::countPointUsage(), meshRefinement::createBaffle(), meshSurfaceEdgeExtractor::createEdgeVertices(), Foam::help::createFaceFromRemovedPart(), Foam::createFIRESelections(), meshUntangler::cutRegion::createInitialConfiguration(), hexRef8::createInternalFaces(), extrudeLayer::createLayerCells(), boundaryLayers::createLayerCells(), boundaryLayers::createNewEdgeVerticesParallel(), boundaryLayers::createNewFacesAndCells(), boundaryLayers::createNewFacesFromPointsParallel(), boundaryLayers::createNewVertex(), extrudeLayer::createNewVertices(), meshOctreeAddressing::createOctreeFaces(), partTetMesh::createPointsAndTets(), tetMeshExtractorOctree::createPolyMesh(), voronoiMeshExtractor::createPolyMesh(), meshUntangler::cutRegion::createPolyMeshFromRegion(), wallBoundedParticle::crossDiagonalEdge(), wallBoundedParticle::crossEdgeConnectedFace(), particle< Type >::crossEdgeConnectedFace(), wallBoundedParticle::currentEdge(), oscillatingFixedValueFvPatchField< Type >::currentScale(), triSurfaceTools::cutEdge(), decompositionMethod::decompose(), decomposeCells::decomposeCellIntoPyramids(), correctEdgesBetweenPatches::decomposeConcaveFaces(), decomposeFaces::decomposeConcaveInternalFaces(), decomposeFaces::decomposeMeshFaces(), correctEdgesBetweenPatches::decomposeProblematicFaces(), autoSnapDriver::detectWarpedFaces(), edgeCollapser::determineDuplicatePointsOnFace(), surfaceToCell::differingPointNormals(), AMIInterpolation< SourcePatch, TargetPatch >::distributeAndMergePatches(), meshSurfaceEdgeExtractor2D::distributeBoundaryFaces(), meshToMesh::distributeCells(), Foam::help::doFaceAndTriangleIntersect(), meshRefinement::doSplitFaces(), Dual< Type >::Dual(), hexRef8::dumpCell(), meshRefinement::dupNonManifoldBoundaryPoints(), dynamicRefineFvMesh::dynamicRefineFvMesh(), PatchTools::edgeOwner(), cell::edges(), directionInfo::edgeToFaceIndex(), cellCuts::edgeVertexToFace(), directionInfo::enterDomain(), surfaceIntersection::excludeEdgeHit(), turbulenceFields::execute(), vtkUnstructuredReader::extractCells(), extrudedMesh::extrudedCells(), extrudedMesh::extrudedFaces(), extrudePatchMesh::extrudeMesh(), cellFeatures::faceAlignedEdge(), meshCutAndRemove::faceCells(), meshCutter::faceCells(), edgeCollapser::faceCollapseAxisAndAspectRatio(), primitiveMeshTools::faceConcavity(), primitiveMesh::faceEdges(), primitiveMeshTools::faceFlatness(), hexRef8::faceLevel(), mappedPatchBase::facePoint(), polyTopoChange::facePoints(), primitiveMeshTools::facePyramidVolume(), cellModel::faces(), extrudeLayer::addressingCalculator::faceSharingEdge(), primitiveMeshTools::faceSkewness(), polyMeshTetDecomposition::faceTetIndices(), walkPatch::faceToFace(), tetIndices::faceTri(), faceTriangulation::faceTriangulation(), tetIndices::faceTriIs(), fanFvPatchField< Type >::fanFvPatchField(), faceCollapser::filterFace(), removeFaces::filterFace(), edgeCollapser::filterFace(), polyMeshGen2DEngine::findActiveFaces(), decomposeCells::findAddressingForCell(), polyMeshTetDecomposition::findBasePoint(), surfaceMorpherCells::findBoundaryVertices(), faceTriangulation::findDiagonal(), autoSnapDriver::findDiagonalAttraction(), localPointRegion::findDuplicateFaces(), patchProbes::findElements(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::findFaceDirs(), checkBoundaryFacesSharingTwoEdges::findFacesAtBndEdge(), detectBoundaryLayers::findHairsForFace(), findCellsIntersectingSurface::findIntersectedCells(), treeDataPrimitivePatch< PatchType >::findIntersection(), medialAxisMeshMover::findIsolatedRegions(), hexRef8::findLevel(), hexRef8::findMaxLevel(), hexRef8::findMinLevel(), treeDataTriSurface::findNearest(), meshSearch::findNearestBoundaryFace(), meshSearch::findNearestBoundaryFaceWalk(), wallBoundedStreamLine::findNearestTet(), sampledSet::findNearFace(), meshUntangler::cutRegion::findNewFaces(), boundaryLayers::findPatchesToBeTreatedTogether(), meshCutAndRemove::findPatchFacePoint(), polyMeshTetDecomposition::findSharedBasePoint(), faceTriangulation::findStart(), polyMeshTetDecomposition::findTet(), cellPointWeight::findTetrahedron(), cellPointWeight::findTriangle(), distributedTriSurfaceMesh::findTriangle(), OSstream::flags(), ISstream::flags(), forAll(), pairPotentialList::force(), pairPotential::force(), Foam::gAverage(), isoSurface::generateFaceTriPoints(), refineBoundaryLayers::refineCornerHexCell::generateMissingFaces(), refineBoundaryLayers::generateNewCells(), refineBoundaryLayers::generateNewCellsPrism(), refineBoundaryLayers::generateNewFaces(), isoSurfaceCell::generateTriPoints(), isoSurfaceCell::genPointTris(), motionSmootherAlgo::getAffectedFacesAndPoints(), hexRef8::getAnchorCell(), coupledPolyPatch::getAnchorPoints(), autoSnapDriver::getFacePoints(), surfaceSets::getHangingCells(), edgeFaceCirculator::getMinIndex(), boundaryMesh::getNearest(), boundaryMesh::getNTris(), polyDualMesh::getPointEdges(), cellDistFuncs::getPointNeighbours(), motionSmootherAlgo::getPoints(), coupledPolyPatch::getRotation(), hexRef8::getSplitPoints(), faceAreaIntersect::getTriPoints(), autoLayerDriver::getVertexString(), treeDataFace::getVolumeType(), treeDataPrimitivePatch< PatchType >::getVolumeType(), autoSnapDriver::getZoneSurfacePoints(), triSurfaceTools::greenRefine(), autoLayerDriver::growNoExtrusion(), boundaryLayerOptimisation::hairEdgesAtBndFace(), medialAxisMeshMover::handleFeatureAngleLayerTerminations(), autoLayerDriver::handleWarpedFaces(), polyTopoChange::hasValidPoints(), wallBoundedParticle::hitProcessorPatch(), particle< Type >::hitWallFaces(), includeEtcEntry::includeEtcFileName(), includeEntry::includeFileName(), distributedTriSurfaceMesh::independentlyDistributedBbs(), FreeStream< CloudType >::inflow(), streamLineBase::initInterpolations(), ParticleCollector< CloudType >::initPolygons(), processorPolyPatch::initUpdateMesh(), meshTriangulation::insertTriangles(), interpolationCellPoint< Foam::Vector >::interpolate(), patchTransformedInterpolation::interpolate(), sampledPlane::interpolateField(), sampledIsoSurfaceCell::interpolateField(), sampledThresholdCellFaces::interpolateField(), sampledPatch::interpolateField(), meshToMesh0::interpolateField(), Foam::interpolatePointToCell(), meshRefinement::intersectedPoints(), face::intersection(), treeDataTriSurface::intersects(), IOField< vector >::IOField(), isoSurface::isEdgeOfFaceCut(), edgeCollapser::isFaceCollapsed(), Foam::help::isFaceConvexAndOk(), meshOctreeAddressing::isIntersectedFace(), isoSurface::isoSurface(), meshStructure::isStructuredCell(), triSurfaceMesh::isSurfaceClosed(), cell::labels(), noiseFFT::Ldelta(), Foam::help::lineFaceIntersection(), meshOptimizer::lockCells(), meshOptimizer::lockFaces(), meshOptimizer::lockPoints(), Foam::longestEdge(), cellCuts::loopAnchorConsistent(), cellCuts::loopFace(), cell::mag(), Foam::mag(), calcMag::magField(), Foam::magSqr(), main(), primitiveMesh::makeCellCentresAndVols(), polyTopoChange::makeCells(), polyMeshGenAddressing::makeFaceCentresAndAreas(), primitiveMesh::makeFaceCentresAndAreas(), Field< Foam::Vector2D >::map(), meshSurfaceMapper::mapEdgeNodes(), meshRefinement::markBoundaryFace(), edgeCollapser::markFaceZoneEdges(), edgeCollapser::markSmallSliverFaces(), momentOfInertia::massPropertiesPatch(), oldCyclicPolyPatch::matchAnchors(), hexRef8::matchHexShape(), Foam::max(), Foam::maxMagSqr(), noiseFFT::meanPf(), removeFaces::mergeFaces(), Foam::help::mergePatchFaces(), polyMeshAdder::mergePoints(), triSurfaceTools::mergePoints(), meshTriangulation::meshTriangulation(), Foam::min(), Foam::minMagSqr(), removeFaces::modFace(), tetDecomposer::modifyFace(), polyTopoChange::modifyFace(), Moment< Type >::Moment(), surfaceMorpherCells::morphInternalFaces(), MPPICParcel::move(), molecule::move(), regionModel1D::moveMesh(), extrudeLayer::movePoints(), primitiveMesh::movePoints(), multiSolidBodyMotionFvMesh::multiSolidBodyMotionFvMesh(), treeDataTriSurface::nearestCoords(), face::nearestPointClassify(), Field< Foam::Vector2D >::NewCalculatedType(), tetIndices::oldFaceTri(), tetIndices::oldTet(), isotropic::oneByTau(), nonEquilibrium::oneByTau(), treeDataPrimitivePatch< PatchType >::findNearestOp::operator()(), treeDataFace::findNearestOp::operator()(), FieldMapper::operator()(), treeDataCell::findIntersectOp::operator()(), treeDataPrimitivePatch< PatchType >::findSelfIntersectOp::operator()(), Foam::operator<<(), Foam::operator>>(), triSurfaceTools::oppositeVertex(), oldCyclicPolyPatch::order(), extrudeLayer::addressingCalculator::origPoint(), edgeFaceCirculator::otherFace(), triSurfaceTools::otherVertices(), distributedTriSurfaceMesh::overlappingSurface(), treeDataTriSurface::overlaps(), searchableRotatedBox::overlaps(), treeDataFace::overlaps(), treeDataPrimitivePatch< PatchType >::overlaps(), Pair< word >::Pair(), CollisionRecordList< vector, vector >::pairAccessed(), CollisionRecordList< vector, vector >::pairData(), CollisionRecordList< vector, vector >::pairOrigIdOfOther(), CollisionRecordList< vector, vector >::pairOrigProcOfOther(), partTetMesh::partTetMesh(), fvPatch::patchInternalField(), blockMesh::patchLabelsOK(), patchWriter::patchWriter(), noiseFFT::Pdelta(), primitiveMesh::pointInCell(), polyMesh::pointInCell(), symmetryPlaneOptimisation::pointInPlanes(), Foam::help::pointInsideFace(), pointMVCWeight::pointMVCWeight(), PatchTools::pointNormals(), cell::points(), extrudeLayer::addressingCalculator::positionInFace(), Foam::help::positionOfEdgeInFace(), Foam::pow(), autoSnapDriver::preventFaceSqueeze(), triSurface::printTriangle(), slidingInterface::projectPoints(), tetOverlapVolume::pyrBb(), face::ray(), OBJsurfaceFormat< Face >::read(), NASsurfaceFormat< Face >::read(), VTKsurfaceFormat< Face >::read(), OFFsurfaceFormat< Face >::read(), AC3DsurfaceFormat< Face >::read(), STARCDsurfaceFormat< Face >::read(), vtkUnstructuredReader::read(), wallBoundedStreamLine::read(), boundaryMesh::read(), STARCD::readCells(), DimensionedField< Type, Foam::pointMesh >::readField(), CollidingParcel::readFields(), triSurface::readNAS(), triSurface::readOFF(), triSurface::readVTK(), processorLduInterface::receive(), globalPoints::receivePatchPoints(), refineBoundaryLayers::refineFace(), autoSnapDriver::releasePointsNextToMultiPatch(), surfaceMorpherCells::removeCellsWithAllVerticesAtTheBoundary(), meshUntangler::cutRegion::removeCoincidentVertices(), polyMeshGenModifier::removeDuplicateFaces(), checkBoundaryFacesSharingTwoEdges::removeExcessiveVertices(), SLListBase::removeHead(), DLListBase::removeHead(), polyMeshGenModifier::removeUnusedVertices(), immersedBoundaryFvPatch::renumberField(), polyMeshGenModifier::reorderBoundaryFaces(), autoSnapDriver::repatchToSurface(), autoSnapDriver::reverseAttractMeshPoints(), Foam::help::reverseFace(), face::reverseFace(), Field< Foam::Vector2D >::rmap(), noiseFFT::RMSmeanPf(), extrudedMesh::sameOrder(), edgeFaceCirculator::sameOrder(), Stochastic< CloudType >::sampleGauss(), decompositionModel::selectIO(), processorLduInterface::send(), edgeFaceCirculator::setCanonical(), IOstream::setf(), addPatchCellLayer::setFaceProps(), faceSource::setFieldValues(), autoLayerDriver::setNumLayers(), removeCells::setRefinement(), duplicatePoints::setRefinement(), perfectInterface::setRefinement(), faceCollapser::setRefinement(), boundaryCutter::setRefinement(), removePoints::setRefinement(), combineFaces::setRefinement(), createShellMesh::setRefinement(), tetDecomposer::setRefinement(), removeFaces::setRefinement(), meshCutAndRemove::setRefinement(), meshCutter::setRefinement(), edgeCollapser::setRefinement(), addPatchCellLayer::setRefinement(), hexRef8::setRefinement(), combineFaces::setUnrefinement(), autoLayerDriver::setupLayerInfoTruncation(), regionToCell::shrinkRegions(), ThermoCloud< CloudType >::sigmap(), autoSnapDriver::smoothInternalDisplacement(), autoSnapDriver::smoothPatchDisplacement(), triSurfaceTools::snapToEnd(), solidBodyMotionFvMesh::solidBodyMotionFvMesh(), sixDoFRigidBodyMotionSolver::solve(), PatchTools::sortedEdgeFaces(), refineBoundaryLayers::sortFaceFaces(), refineBoundaryLayers::sortFacePoints(), faceTriangulation::split(), autoSnapDriver::splitDiagonals(), boundaryCutter::splitFace(), meshCutAndRemove::splitFace(), meshCutter::splitFace(), meshRefinement::splitMesh(), Foam::sqr(), AMIInterpolation< SourcePatch, TargetPatch >::srcPointFace(), Foam::stabilise(), MeshedSurface< Foam::face >::stitchFaces(), triSurface::stitchTriangles(), isoSurface::stitchTriPoints(), PatchTools::subsetMap(), distributedTriSurfaceMesh::subsetMesh(), isoSurfaceCell::subsetMesh(), UnsortedMeshedSurface< Face >::subsetMesh(), MeshedSurface< Foam::face >::subsetMesh(), distributedTriSurfaceMesh::subsetMeshMap(), motionSmootherAlgo::subtractField(), Foam::sum(), Foam::sumCmptMag(), Foam::sumMag(), Foam::sumSqr(), surfaceMeshWriter::surfaceMeshWriter(), triSurfaceTools::surfaceNormal(), triSurfaceTools::surfaceSide(), SVD::SVD(), swapec(), syncTools::syncEdgeMap(), Foam::T(), thermo< Thermo, Type >::T(), tetIndices::tet(), Dual< Type >::tetGeometry(), tetIndices::tetIndices(), particle< Type >::tetNeighbour(), AMIInterpolation< SourcePatch, TargetPatch >::tgtPointFace(), meshUntangler::cutRegion::tieBreak(), Time::Time(), fileName::toAbsolute(), wallBoundedParticle::trackToEdge(), particle< Type >::trackToFace(), cyclicACMILduInterfaceField::transformCoupleField(), cyclicAMILduInterfaceField::transformCoupleField(), cyclicLduInterfaceField::transformCoupleField(), processorLduInterfaceField::transformCoupleField(), Foam::transformFieldMask(), faceAreaIntersect::triangleFan(), polyMeshTetDecomposition::triangleTetIndices(), faceHeatShading::triangulate(), faceShading::triangulate(), boundaryMesh::triangulate(), triSurfaceTools::triangulate(), triSurfaceTools::triangulateFaceCentre(), boundaryMesh::triangulateLocal(), triFace::triFaceFace(), tetDecomposer::triIndex(), isoSurface::trimToBox(), autoLayerDriver::truncateDisplacement(), removeCells::uncount(), meshOptimizer::untangleMeshFV(), meshSurfaceOptimizer::untangleSurface2D(), sampledTriSurfaceMesh::update(), MPPICParcel::TrackingData< CloudType >::updateAverages(), extrudeLayer::updateBoundary(), directionInfo::updateCell(), sixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs(), outletMappedUniformInletFvPatchField< Type >::updateCoeffs(), fWallFunctionFvPatchScalarField::updateCoeffs(), patchFaceOrientation::updateEdge(), patchEdgeFaceRegions::updateEdge(), patchFaceOrientation::updateFace(), patchEdgeFaceRegions::updateFace(), primitiveMeshGeometry::updateFaceCentresAndAreas(), polyMeshGeometry::updateFaceCentresAndAreas(), polyMeshGenAddressing::updateGeometry(), patchInjectionBase::updateMesh(), processorPolyPatch::updateMesh(), removePoints::updateMesh(), combineFaces::updateMesh(), cellClassification::usesMixedPointsOnly(), combineFaces::validFace(), isoSurfaceCell::validTri(), isoSurface::validTri(), cellCuts::vertexVertexToFace(), vtkTopo::vtkTopo(), cuttingPlane::walkCellCuts(), intersectedSurface::walkFace(), hexRef8::walkFaceFromMid(), hexRef8::walkFaceToMid(), CollisionRecordList< vector, vector >::wallAccessed(), CollisionRecordList< vector, vector >::wallData(), wallLayerCells::wallLayerCells(), CollisionRecordList< vector, vector >::wallPRel(), face::which(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), VTKsurfaceFormat< Face >::write(), AC3DsurfaceFormat< Face >::write(), OFFsurfaceFormat< Face >::write(), TRIsurfaceFormat< Face >::write(), STARCDsurfaceFormat< Face >::write(), OBJstream::write(), AveragingMethod< Foam::Vector >::write(), immersedBoundaryFvPatchField< Type >::write(), triSurface::writeAC(), forces::writeBinnedForceMoment(), STARCD::writeCells(), ensightPartFaces::writeConnectivity(), triSurface::writeDXGeometry(), fpmaMesh::writeFaces(), CollidingParcel::writeFields(), fieldAverage::writeFieldType(), vtkSurfaceWriter::writeGeometry(), dxSurfaceWriter::writeGeometry(), nastranSurfaceWriter::writeGeometry(), externalCoupledFunctionObject::writeGeometry(), AABBTree::writeOBJ(), removeFaces::writeOBJ(), intersectedSurface::writeOBJ(), Foam::meshTools::writeOBJ(), coupledPolyPatch::writeOBJ(), enrichedPatch::writeOBJ(), TRIsurfaceFormat< Face >::writeShell(), STLsurfaceFormat< Face >::writeShell(), STARCDsurfaceFormat< Face >::writeShell(), triSurface::writeStats(), triSurface::writeSTLASCII(), triSurface::writeSTLBINARY(), nastranSurfaceWriter::writeTemplate(), PrimitivePatch< labelledTri, List, pointField, point >::writeVTK(), alphatJayatillekeWallFunctionFvPatchScalarField::yPlusTherm(), and polyMeshGenModifier::zipUpCells().

◆ bcl()

labelList bcl ( nPoints  )

◆ bcf()

labelList bcf ( nPoints  )

◆ bcb()

labelList bcb ( nPoints  )

◆ if() [2/4]

if ( mTable  = = 0)

Definition at line 77 of file readKivaGrid.H.

References Foam::exit(), Foam::FatalError, and FatalErrorInFunction.

Here is the call graph for this function:

◆ imtab()

labelList imtab ( nPoints  )

◆ jmtab()

labelList jmtab ( nPoints  )

◆ kmtab()

labelList kmtab ( nPoints  )

◆ quadFace()

face quadFace ( )

Referenced by blockMesh::createPatchFaces(), and if().

Here is the caller graph for this function:

◆ triFace()

face triFace ( )

◆ if() [3/4]

if ( pFaces.  size() &&pFaces.size() &&pFaces.size() &&pFaces.size()[LINER][LINER][0][CYLINDERHEAD][CYLINDERHEAD][0])

Definition at line 321 of file readKivaGrid.H.

References Foam::endl(), forAll(), forAllConstIter(), Foam::Info, Foam::min(), pFaces, and points().

Here is the call graph for this function:

◆ if() [4/4]

if ( pFaces.  size() &&pFaces.size()[WEDGE][WEDGE][0])

Definition at line 416 of file readKivaGrid.H.

References cellShapes, Foam::degToRad(), forAllIter, nPatches, pFaces, points(), and Foam::tan().

Here is the call graph for this function:

◆ boundary()

faceListList boundary ( nPatches  )

◆ patchNames()

wordList patchNames ( nPatches  )

Referenced by autoRefineDriver::addFaceZones(), checkMeshDict::checkBoundaryLayers(), polyBoundaryMesh::checkDefinition(), checkMeshDict::checkKeepCellsIntersectingPatches(), checkMeshDict::checkPatchCellSize(), checkMeshDict::checkRemoveCellsIntersectingPatches(), checkMeshDict::checkRenameBoundary(), thermalBaffleFvPatchScalarField::createPatchMesh(), cartesianMeshExtractor::createPolyMesh(), blockMesh::createTopology(), meshSurfaceEdgeExtractorFUN::distributeBoundaryFaces(), meshSurfaceEdgeExtractor2D::distributeBoundaryFaces(), extrudePatchMesh::extrudePatchMesh(), meshOctreeAddressing::findUsedBoxes(), patchTransformedInterpolation::getPatches(), getPatchIds(), cellDistFuncs::getPatchIDs(), main(), patchInjection::patchInjection(), polyBoundaryMesh::patchSet(), polyMeshGenFaces::polyMeshGenFaces(), Foam::preservePatchTypes(), sampledPatchInternalField::print(), sampledPatch::print(), blockMesh::readBoundary(), blockMesh::readPatches(), refineBoundaryLayers::readSettings(), polyMeshGenModifier::replaceBoundary(), surfaceMorpherCells::replaceMeshBoundary(), subTriSurfaceMesh::selectedRegions(), fvMeshSubset::setLargeCellSubset(), meshOctreeCreator::setRootCubeSizeAndRefParameters(), subTriSurfaceMesh::subset(), extrudeLayer::updateBoundary(), checkMeshDict::updateKeepCellsIntersectingPatches(), edgeExtractor::updateMeshPatches(), checkMeshDict::updatePatchCellSize(), checkMeshDict::updateRemoveCellsIntersectingPatches(), and wallLayerCells::wallLayerCells().

Here is the caller graph for this function:

◆ patchTypes()

wordList patchTypes ( nPatches  )

◆ pointLabels()

labelList pointLabels ( nPoints  ,
1 
)

◆ forAll() [1/4]

forAll ( cellShapes  ,
celli   
)

Definition at line 492 of file readKivaGrid.H.

References cellShapes, and pointLabels().

Referenced by forAll(), and if().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ forAll() [2/4]

forAll ( pointLabels  ,
pointi   
)

Definition at line 502 of file readKivaGrid.H.

References newPointi, pointLabels(), and points().

Here is the call graph for this function:

◆ setSize()

points setSize ( newPointi  )

Referenced by polyTopoChanger::addTopologyModifiers(), LongList< Foam::meshOctreeCube >::appendFromStream(), Field< Foam::Vector2D >::autoMap(), tetherPotentialList::buildPotentials(), pairPotentialList::buildPotentials(), cyclicAMIPolyPatch::calcTransforms(), cyclicPolyPatch::calcTransforms(), CloudFunctionObjectList< KinematicCloud< CloudType > >::CloudFunctionObjectList(), coalCloudList::coalCloudList(), face::collapse(), nearWallDist::correct(), patchPatchDist::correct(), DynList< Foam::triFace >::DynList(), faceTriangulation::faceTriangulation(), forceList::forceList(), processorFvPatchField< Type >::initEvaluate(), InjectionModelList< Foam::KinematicCloud< Foam::DSMCCloud > >::InjectionModelList(), injectionModelList::injectionModelList(), labelRanges::insertBefore(), IOField< vector >::IOField(), IOList< labelList >::IOList(), IOMap< T >::IOMap(), List< substance >::List(), LongList< Foam::meshOctreeCube >::LongList(), main(), List< substance >::newElmt(), LongList< Foam::meshOctreeCube >::operator()(), DynamicList< Foam::FixedList< scalar, 3 > >::operator()(), DynamicField::operator()(), LongList< Foam::meshOctreeCube >::operator=(), PackedBoolList::operator=(), PtrList< injectionModel >::operator=(), ParticleForceList< KinematicCloud< CloudType > >::ParticleForceList(), profileModelList::profileModelList(), PtrListDictionary< phaseModel >::PtrListDictionary(), PtrList< injectionModel >::read(), primitiveEntry::readEntry(), GeometricField::GeometricBoundaryField::readField(), regionModelFunctionObjectList::regionModelFunctionObjectList(), DynamicList< Foam::FixedList< scalar, 3 > >::reserve(), DynamicField::reserve(), MRFZoneList::reset(), porosityModelList::reset(), optionList::reset(), UPtrList< Foam::Field< Type > >::resize(), CompactListList::resize(), PtrList< injectionModel >::resize(), DynamicList< Foam::FixedList< scalar, 3 > >::setCapacity(), DynamicField::setCapacity(), sampledSet::setSamples(), pointFieldPMG::setSize(), LongList< Foam::meshOctreeCube >::shrink(), DynamicList< Foam::FixedList< scalar, 3 > >::shrink(), DynamicField::shrink(), ParSortableList< Type >::sort(), triSurface::stitchTriangles(), and uniformInterpolationTable< scalar >::uniformInterpolationTable().

◆ forAll() [3/4]

forAll ( boundary  ,
patchi   
)

Definition at line 524 of file readKivaGrid.H.

References boundary(), f(), forAll(), patchi, and pointLabels().

Here is the call graph for this function:

◆ preservePatchTypes()

preservePatchTypes ( runTime  ,
runTime.  constant(),
polyMesh::meshSubDir  ,
patchNames  ,
patchDicts  ,
defaultFacesName  ,
defaultFacesType   
)

Referenced by blockMesh::createTopology().

Here is the caller graph for this function:

◆ forAll() [4/4]

forAll ( patchNames  ,
patchI   
)

Definition at line 549 of file readKivaGrid.H.

References patchDicts, and patchTypes().

Here is the call graph for this function:

◆ pShapeMesh()

polyMesh pShapeMesh ( IOobject(polyMesh::defaultRegion, runTime.constant(), runTime)  ,
xferMove(points ,
cellShapes  ,
boundary  ,
patchNames  ,
patchDicts  ,
defaultFacesName  ,
defaultFacesType   
)

Variable Documentation

◆ nRegs

Info<< "Reading kiva grid from file " << kivaFileName << endl;char title[120];kivaFile.getline(title, 120, '\n');label nPoints, nCells, nRegs;kivaFile > nCells nPoints nRegs

Definition at line 17 of file readKivaGrid.H.

◆ i4

label i4

Definition at line 20 of file readKivaGrid.H.

Referenced by for().

◆ nBfaces

label nBfaces = 0

Definition at line 45 of file readKivaGrid.H.

Referenced by meshRefinement::markFacesOnProblemCells().

◆ mTable

kivaFile mTable

Definition at line 74 of file readKivaGrid.H.

◆ pFaces

Info<< "Finished reading KIVA file" << endl;cellShapeList cellShapes(nPoints);labelList cellZoning(nPoints, -1);const cellModel& hex = *(cellModeller::lookup("hex"));labelList hexLabels(8);label activeCells = 0;labelList pointMap(nPoints);forAll(pointMap, i){ pointMap[i] = i;}for (label i=0; i<nPoints; i++){ if (f[i] > 0.0) { hexLabels[0] = i; hexLabels[1] = i1tab[i]; hexLabels[2] = i3tab[i1tab[i]]; hexLabels[3] = i3tab[i]; hexLabels[4] = i8tab[i]; hexLabels[5] = i1tab[i8tab[i]]; hexLabels[6] = i3tab[i1tab[i8tab[i]]]; hexLabels[7] = i3tab[i8tab[i]]; cellShapes[activeCells] = cellShape(hex, hexLabels); edgeList edges = cellShapes[activeCells].edges(); forAll(edges, ei) { if (edges[ei].mag(points) < SMALL) { label start = pointMap[edges[ei].start()]; while (start != pointMap[start]) { start = pointMap[start]; } label end = pointMap[edges[ei].end()]; while (end != pointMap[end]) { end = pointMap[end]; } label minLabel = min(start, end); pointMap[start] = pointMap[end] = minLabel; } } cellZoning[activeCells] = idreg[i]; activeCells++; }}cellShapes.setSize(activeCells);cellZoning.setSize(activeCells);forAll(cellShapes, celli){ cellShape& cs = cellShapes[celli]; forAll(cs, i) { cs[i] = pointMap[cs[i]]; } cs.collapse();}label bcIDs[11] = {-1, 0, 2, 4, -1, 5, -1, 6, 7, 8, 9};const label nBCs = 12;const word* kivaPatchTypes[nBCs] ={ &wallPolyPatch::typeName, &wallPolyPatch::typeName, &wallPolyPatch::typeName, &wallPolyPatch::typeName, &symmetryPolyPatch::typeName, &wedgePolyPatch::typeName, &polyPatch::typeName, &polyPatch::typeName, &polyPatch::typeName, &polyPatch::typeName, &symmetryPolyPatch::typeName, &oldCyclicPolyPatch::typeName};enum patchTypeNames{ PISTON, VALVE, LINER, CYLINDERHEAD, AXIS, WEDGE, INFLOW, OUTFLOW, PRESIN, PRESOUT, SYMMETRYPLANE, CYCLIC};const char* kivaPatchNames[nBCs] ={ "piston", "valve", "liner", "cylinderHead", "axis", "wedge", "inflow", "outflow", "presin", "presout", "symmetryPlane", "cyclic"};List<SLList<face> > pFaces[nBCs]

Definition at line 235 of file readKivaGrid.H.

Referenced by singleProcessorFaceSetsConstraint::add(), globalPoints::addToSend(), singleProcessorFaceSetsConstraint::apply(), autoSnapDriver::avgCellCentres(), cellCuts::calcAnchors(), Foam::meshTools::calcBoxPointNormals(), autoSnapDriver::calcNearestFacePointProperties(), isoSurfaceCell::calcSnappedPoint(), isoSurface::calcSnappedPoint(), meshSurfaceEngine::calculateEdgesAndAddressing(), meshSurfaceEngine::calculatePointNormals(), meshSurfaceEngine::calculatePointPatches(), meshSurfaceEngine::calculatePointPoints(), calcVertexNormals(), polyMeshTetDecomposition::cellTetIndices(), edgeExtractor::checkCorners(), PrimitivePatch< labelledTri, List, pointField, point >::checkPointManifold(), polyDualMesh::collectPatchInternalFace(), polyDualMesh::collectPatchSideFace(), pointToFace::combine(), cellCuts::conservativeValidLoop(), boundaryLayers::createLayerCells(), boundaryLayers::createNewEdgeVerticesParallel(), boundaryLayers::createNewVertex(), edgeExtractor::cornerEvaluator::createParallelAddressing(), particle< Type >::crossEdgeConnectedFace(), decompositionMethod::decompose(), polyMeshTetDecomposition::faceTetIndices(), tetIndices::faceTri(), tetIndices::faceTriIs(), cellClassification::fillRegionPoints(), polyMeshTetDecomposition::findBasePoint(), localPointRegion::findDuplicateFaces(), meshCutAndRemove::findInternalFacePoint(), meshCutter::findInternalFacePoint(), medialAxisMeshMover::findIsolatedRegions(), meshSurfaceMapper::findMappingDistance(), meshCutAndRemove::findPatchFacePoint(), polyMeshTetDecomposition::findSharedBasePoint(), polyMeshTetDecomposition::findTet(), cellPointWeight::findTetrahedron(), distributedTriSurfaceMesh::findTriangle(), detectBoundaryLayers::generateHairEdges(), removeFaces::getFacesAffected(), cellLooper::getVertFacesNonEdge(), treeDataFace::getVolumeType(), particle< Type >::hitWallFaces(), if(), edgeExtractor::cornerEvaluator::improveCorners(), interpolationCellPoint< Foam::Vector >::interpolate(), volPointInterpolation::interpolateBoundaryField(), triSurfaceMesh::isSurfaceClosed(), volPointInterpolation::makeBoundaryWeights(), hexRef8::matchHexShape(), removeFaces::mergeFaces(), meshSurfaceEngineModifier::moveBoundaryVertex(), meshSurfaceOptimizer::nodeDisplacementLaplacianFCParallel(), tetIndices::oldFaceTri(), tetIndices::oldTet(), boundaryLayerOptimisation::optimiseHairNormalsAtTheBoundary(), boundaryLayerOptimisation::optimiseThicknessVariation(), oldCyclicPolyPatch::order(), autoSnapDriver::outwardsDisplacement(), boundaryMesh::patchify(), primitiveMesh::pointCells(), PatchTools::pointNormals(), Foam::polyMeshZipUpCells(), perfectInterface::setRefinement(), removePoints::setRefinement(), hexRef8::setUnrefinement(), autoSnapDriver::smoothPatchDisplacement(), edgeExtractor::cornerEvaluator::sortedFacesAtPoint(), meshRefinement::splitMesh(), isoSurface::stitchTriPoints(), edgeExtractor::surfaceWithPatches(), tetIndices::tet(), tetIndices::tetIndices(), particle< Type >::tetNeighbour(), triSurfaceTools::trackToEdge(), particle< Type >::trackToFace(), dynamicRefineFvMesh::unrefine(), meshSurfaceEngineModifier::updateGeometry(), meshSurfaceEngine::updatePointNormalsAtProcBoundaries(), PrimitivePatch< labelledTri, List, pointField, point >::visitPointRegion(), cellCuts::walkPoint(), topoCellLooper::walkSplitHex(), and polyMeshGenModifier::zipUpCells().

◆ nPatches

label nPatches = 0

◆ defaultFacesName

word defaultFacesName = "defaultFaces"

Definition at line 460 of file readKivaGrid.H.

Referenced by main(), and Foam::preservePatchTypes().

◆ defaultFacesType

word defaultFacesType = emptyPolyPatch::typeName

◆ nAddedPatches

label nAddedPatches = 0

Definition at line 463 of file readKivaGrid.H.

◆ newPointi

label newPointi = 0

Definition at line 501 of file readKivaGrid.H.

Referenced by forAll().

◆ patchDicts

PtrList<dictionary> patchDicts