
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), move(points), cellShapes, boundary, patchNames, patchDicts, defaultFacesName, defaultFacesType) |
| polyMeshUnMergeCyclics (pShapeMesh) | |
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 | 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, &mergedCyclicPolyPatch::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 |
| ifstream kivaFile | ( | kivaFileName. | c_str() | ) |
| if | ( | !kivaFile. | good() | ) |
Definition at line 3 of file readKivaGrid.H.
References Foam::exit(), Foam::FatalError, and FatalErrorInFunction.

| pointField points | ( | nPoints | ) |
| labelList idface | ( | nPoints | ) |
| labelList fv | ( | nPoints | ) |
Referenced by for(), if(), and makeMomentumTransportModelTypes().

| for | ( | ) |
Definition at line 23 of file readKivaGrid.H.
References fv(), i4, idface(), kivaFile(), and points().

| labelList i1tab | ( | nPoints | ) |
| labelList i3tab | ( | nPoints | ) |
| labelList i8tab | ( | nPoints | ) |
| labelList idreg | ( | nPoints | ) |
| labelList f | ( | nPoints | ) |
Referenced by singleProcessorFaceSetsConstraint::add(), multivariateSurfaceInterpolationScheme< Type >::fieldTable::add(), polyTopoChange::addFace(), fvTotalSource::addSource(), regIOobject::addWatch(), fileOperation::addWatches(), masterUncollatedFileOperation::addWatches(), waveAlphaFvPatchScalarField::alphan(), MPLICface::alphaPhiU(), singleProcessorFaceSetsConstraint::apply(), face::areaAndCentreStabilised(), Foam::average(), face::average(), cell::bb(), booleanSurface::booleanSurface(), Foam::meshCheck::boundaryFaceSkewness(), box::boundingSpheres(), triSurface::boundingSpheres(), PatchTools::calcBounds(), BrownianMotionForce< CloudType >::calcCoupled(), cellMatcher::calcEdgeAddressing(), coupledPolyPatch::calcFaceTol(), triSurfaceTools::calcInterpolationWeights(), cellMatcher::calcLocalFaces(), cellMatcher::calcPointFaceIndex(), primitiveMesh::calcPointOrder(), createShellMesh::calcPointRegions(), rotorDisk::calculate(), KocamustafaogullariIshiiNucleationSite::calculate(), nutUSpaldingWallFunctionFvPatchScalarField::calcUTau(), pointMVCWeight::calcWeights(), cellEdgeAddressingData::cellEdgeAddressingData(), cellMatcher::cellMatcher(), primitiveMesh::cellPoints(), tetOverlapVolume::cellVolumeMinDecomp(), cellPoint< Type >::cellVolumeWeightedSum(), cell::centre(), repatcher::changeAnchorPoint(), Foam::meshCheck::checkCellsZipUp(), Foam::meshCheck::checkCoupledPoints(), Foam::meshCheck::checkEdgeAlignment(), Foam::meshCheck::checkEdgeLength(), Foam::meshCheck::checkFaceAngles(), Foam::meshCheck::checkFaceFlatness(), Foam::meshCheck::checkFacePyramids(), MeshedSurface< Face >::checkFaces(), Foam::meshCheck::checkFaceTet(), polyMeshTetDecomposition::checkFaceTets(), Foam::meshCheck::checkFaceTwist(), Foam::meshCheck::checkFaceVertices(), hexRef8::checkMesh(), edgeCollapser::checkMeshQuality(), PatchTools::checkOrientation(), CollisionRecordList< vector, vector >::checkPairRecord(), searchableSurfaceList::checkQuality(), Foam::meshCheck::checkTopology(), triSurface::checkTriangles(), Foam::meshCheck::checkTriangleTwist(), CollisionRecordList< vector, vector >::checkWallRecord(), Foam::meshCheck::checkWedges(), TomiyamaLift::Cl(), ensightPartFaces::classify(), Foam::cmptAv(), Foam::cmptMag(), Foam::cmptMax(), Foam::cmptMin(), cellShape::collapsedFaces(), triSurfaceTools::collapseEdges(), ORourkeCollision< CloudType >::collideSorted(), Foam::component(), processorLduInterface::compressedReceive(), processorLduInterface::compressedSend(), edgeCollapser::consistentCollapse(), bound::constrain(), CentredFitScheme< Type, Polynomial, Stencil >::correction(), pointLinear< Type >::correction(), removePoints::countPointUsage(), triSurface::curvature(), MPLICface::cutFace(), decompositionMethod::decompose(), cellsToCells::distributeMesh(), snappySnapDriver::doSnap(), PatchTools::edgeOwner(), cell::edges(), directionInfo::edgeToFaceIndex(), BlendedInterfacialModel< ModelType >::evaluate(), turbulenceFields::execute(), blendingMethod::f1DispersedIn2(), blendingMethod::f2DispersedIn1(), Foam::cutPoly::faceArea(), Foam::meshCheck::faceConcavity(), Foam::cutPoly::faceCutArea(), Foam::cutPoly::faceCuts(), primitiveMesh::faceEdges(), Foam::meshCheck::faceFlatness(), hexRef8::faceLevel(), FacePatchIntersection< SrcPatchType, TgtPatchType >::FacePatchIntersection(), Foam::meshCheck::facePyramidVolume(), cellModel::faces(), Foam::meshCheck::faceSkewness(), polyMeshTetDecomposition::faceTetIndices(), tetIndices::faceTriIs(), blendingMethod::fDisplaced(), polyMeshTetDecomposition::findBasePoint(), localPointRegion::findDuplicateFaces(), treeDataPrimitivePatch< PatchType >::findIntersection(), meshSearch::findNearestBoundaryFace(), polyMeshTetDecomposition::findSharedBasePoint(), polyMeshTetDecomposition::findTet(), Foam::first(), dummyISstream::flags(), dummyIstream::flags(), ISstream::flags(), OSstream::flags(), Foam::tracking::toCell< Foam::Pair< Foam::vector > >(), forAll(), pairPotentialList::force(), pairPotential::force(), Foam::gAverage(), face::generate(), point::generate(), surfaceFieldValue::getFieldValues(), surfaceSets::getHangingCells(), edgeFaceCirculator::getMinIndex(), repatchMesh::getNearest(), hexRef8::getSplitPoints(), treeDataFace::getVolumeType(), treeDataPrimitivePatch< PatchType >::getVolumeType(), snappySnapDriver::getZoneSurfacePoints(), includeEntry::includeFileName(), FreeStream< CloudType >::inflow(), coupledPolyPatch::initOrder(), processorPolyPatch::initTopoChange(), waveSpectrum::integralFS(), PiersonMoskowitz::integralS(), waveSpectrum::integralS(), linearInterpolationWeights::integrationWeights(), Foam::blendedInterfacialModel::interpolate(), patch::interpolateField(), thresholdCellFaces::interpolateField(), Foam::interpolatePointToCell(), meshRefinement::intersectedPoints(), face::intersection(), IOField< Type >::IOField(), irregular::irregular(), fileOperation::isFileOrDir(), function::jcalc(), functionDot::jcalc(), cell::labels(), noiseFFT::Ldelta(), Foam::levelSetFraction(), Foam::listConfigFiles(), Foam::tracking::locate(), Foam::longestEdge(), basicThermo::lookupThermo(), cell::mag(), Foam::mag(), Foam::magSqr(), edgeCollapser::markFaceZoneEdges(), edgeCollapser::markSmallSliverFaces(), Foam::max(), adjustTimeStepToCombustion::maxDeltaT(), Foam::maxMagSqr(), noiseFFT::meanPf(), triSurfaceTools::mergePoints(), meshTriangulation::meshTriangulation(), Foam::min(), Foam::minMagSqr(), polyMeshTetDecomposition::minQuality(), volumeInjection::modify(), polyTopoChange::modifyFace(), findCellParticle::move(), trackedParticle::move(), molecule::move(), sampledSetParticle::move(), solidParticle::move(), DSMCParcel< ParcelType >::move(), MomentumParcel< ParcelType >::move(), primitiveMesh::movePoints(), multiSolidBodyMotionSolver::multiSolidBodyMotionSolver(), face::nearestPointClassify(), Field< Type >::NewCalculatedType(), isotropic::oneByTau(), nonEquilibrium::oneByTau(), ConstMatrixBlock< MatrixType >::operator Field< cmptType >(), MatrixBlock< MatrixType >::operator Field< cmptType >(), spatialTransform::transpose::operator&(), spatialTransform::dual::operator&(), inversePointDistanceDiffusivity::operator()(), LagrangianMesh::parabolicDisplacement::operator()(), treeDataPrimitivePatch< PatchType >::findSelfIntersectOp::operator()(), treeDataCell::findIntersectOp::operator()(), treeDataFace::findNearestOp::operator()(), treeDataPrimitivePatch< PatchType >::findNearestOp::operator()(), patchToPatchFieldMapper::operator()(), fieldMapper::operator()(), Foam::tracking::operator*(), Field< tensor >::operator/=(), Foam::operator<<(), MatrixBlock< MatrixType >::operator=(), FieldField< Field, Type >::operator=(), Function1< Type >::operator=(), Function2< Type >::operator=(), Foam::operator>>(), Foam::operator^(), triSurfaceTools::oppositeVertex(), triSurfaceTools::otherVertices(), distributedTriSurface::overlappingSurface(), treeDataFace::overlaps(), treeDataPrimitivePatch< PatchType >::overlaps(), CollisionRecordList< PairType, WallType >::pairAccessed(), CollisionRecordList< PairType, WallType >::pairData(), CollisionRecordList< PairType, WallType >::pairOrigIdOfOther(), CollisionRecordList< vector, vector >::pairOrigProcOfOther(), fvPatch::patchInternalField(), noiseFFT::Pdelta(), distribution::plotX(), standardNormal::plotX(), primitiveMesh::pointInCell(), polyMesh::pointInCell(), pointMVCWeight::pointMVCWeight(), PatchTools::pointNormals(), cell::points(), cellPoint< Type >::pointVolumeWeightedSum(), Foam::pow(), face::ray(), AC3DsurfaceFormat< Face >::read(), NASsurfaceFormat< Face >::read(), OBJsurfaceFormat< Face >::read(), OFFsurfaceFormat< Face >::read(), VTKsurfaceFormat< Face >::read(), repatchMesh::read(), STARCD::readCells(), DimensionedField< Type, GeoMesh, PrimitiveField >::readField(), CollidingParcel< ParcelType >::readFields(), liquidProperties::readIfPresent(), processorLduInterface::receive(), refiner::refiner(), DLListBase::removeHead(), SLListBase::removeHead(), snappySnapDriver::repatchToSurface(), Field< tensor >::replace(), ODESolver::resizeField(), face::reverseFace(), Field< Type >::rmap(), noiseFFT::RMSmeanPf(), GodaJONSWAP::S(), JONSWAP::S(), PiersonMoskowitz::S(), edgeFaceCirculator::sameOrder(), unintegrable::sampleInterval(), mappedInternalPatchBase::samplePoints(), sampledSurfaces::sampleType(), processorLduInterface::send(), edgeFaceCirculator::setCanonical(), IOstream::setf(), removePoints::setRefinement(), meshCutter::setRefinement(), perfectInterface::setRefinement(), hexRef8::setRefinement(), removeCells::setRefinement(), combineFaces::setRefinement(), edgeCollapser::setRefinement(), duplicatePoints::setRefinement(), createShellMesh::setRefinement(), addPatchCellLayer::setRefinement(), combineFaces::setUnrefinement(), ThermoCloud< CloudType >::sigmap(), rigidBodyMeshMotion::solve(), rigidBodyMeshMotionSolver::solve(), sixDoFRigidBodyMotionSolver::solve(), PatchTools::sortedEdgeFaces(), meshRefinement::splitFaces(), meshRefinement::splitMesh(), fileOperation::splitProcessorPath(), Foam::sqr(), Foam::stabilise(), MeshedSurface< Face >::stitchFaces(), PatchTools::subsetMap(), MeshedSurface< Face >::subsetMesh(), UnsortedMeshedSurface< Face >::subsetMesh(), triSurface::subsetMeshMap(), Foam::sum(), Foam::sumCmptMag(), Foam::sumMag(), Foam::sumSqr(), triSurfaceTools::surfaceNormal(), triSurfaceTools::surfaceSide(), SVD::SVD(), swapec(), syncTools::syncEdgeMap(), thermo< Thermo, Type >::T(), Foam::T(), Foam::tetCutPrism0(), Foam::tetCutPrism01(), Foam::tetCutPrism23(), Foam::tetCutTet(), fileName::toAbsolute(), combineFaces::topoChange(), removePoints::topoChange(), processorPolyPatch::topoChange(), unitConversion::toStandard(), unitConversion::toUser(), particle::trackToAndHitFace(), filmVoFTransfer::TransferRate(), VoFFilmTransfer::TransferRate(), directionInfo::transform(), cyclicLduInterfaceField::transformCoupleField(), processorLduInterfaceField::transformCoupleField(), Foam::transformFieldMask(), triSurfaceTools::triangulate(), MeshedSurface< Face >::triangulate(), triSurfaceTools::triangulateFaceCentre(), Foam::triCutQuad(), Foam::triCutTri(), triFace::triFaceFace(), waveVelocityFvPatchVectorField::Un(), MPPICParcel< ParcelType >::trackingData::updateAverages(), directionInfo::updateCell(), outletMappedUniformInletFvPatchField< Type >::updateCoeffs(), fWallFunctionFvPatchScalarField::updateCoeffs(), externalTemperatureFvPatchScalarField::updateCoeffs(), patchFaceOrientation::updateEdge(), patchEdgeFaceRegions::updateEdge(), patchFaceOrientation::updateFace(), patchEdgeFaceRegions::updateFace(), linearInterpolationWeights::valueWeights(), volPointInterpolation::volPointInterpolation(), CollisionRecordList< PairType, WallType >::wallAccessed(), CollisionRecordList< PairType, WallType >::wallData(), CollisionRecordList< vector, vector >::wallData(), CollisionRecordList< vector, vector >::wallPRel(), CollisionRecordList< PairType, WallType >::wallPRel(), face::which(), cloudSurfaceDistribution::write(), SizeDistribution< CloudType >::write(), AC3DsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), OFFsurfaceFormat< Face >::write(), SMESHsurfaceFormat< Face >::write(), STARCDsurfaceFormat< Face >::write(), TRIsurfaceFormat< Face >::write(), VTKsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), X3DsurfaceFormat< Face >::write(), liquidProperties::write(), OBJstream::write(), forcesBase::writeBins(), ensightPartFaces::writeConnectivity(), Foam::writeEntry(), Foam::cutPoly::writeFaceCuts(), CollidingParcel< ParcelType >::writeFields(), fieldAverage::writeFieldType(), forcesBase::writeFileHeader(), coupledPolyPatch::writeOBJ(), Foam::meshTools::writeOBJ(), triSurface::writeStats(), alphatJayatillekeWallFunctionFvPatchScalarField::yPlusTherm(), and GlobalIOListBase< List, GlobalIOList, Type >::~GlobalIOListBase().
| labelList bcl | ( | nPoints | ) |
| labelList bcf | ( | nPoints | ) |
| labelList bcb | ( | nPoints | ) |
| if | ( | mTable | = = 0 | ) |
Definition at line 71 of file readKivaGrid.H.
References Foam::exit(), Foam::FatalError, and FatalErrorInFunction.

| labelList imtab | ( | nPoints | ) |
| labelList jmtab | ( | nPoints | ) |
| labelList kmtab | ( | nPoints | ) |
| face quadFace | ( | 4 | ) |
| face triFace | ( | 3 | ) |
Referenced by tetCell::face(), tetIndices::faceTriIs(), if(), momentOfInertia::massPropertiesShell(), momentOfInertia::massPropertiesSolid(), MPLICcell::MPLICcell(), AC3DsurfaceFormat< Face >::read(), GTSsurfaceFormat< Face >::read(), NASsurfaceFormat< Face >::read(), OBJsurfaceFormat< Face >::read(), OFFsurfaceFormat< Face >::read(), STLsurfaceFormat< Face >::read(), TRIsurfaceFormat< Face >::read(), VTKsurfaceFormat< Face >::read(), triFace::reverseFace(), MeshedSurface< Face >::transcribe(), and MeshedSurface< Face >::triangulate().

| if | ( | pFaces. | size() &&pFaces.size() &&pFaces.size() &&pFaces.size()[LINER][LINER][0][CYLINDERHEAD][CYLINDERHEAD][0] | ) |
Definition at line 314 of file readKivaGrid.H.
References Foam::endl(), forAll(), forAllConstIter, Foam::Info, Foam::min(), pFaces, and points().

| if | ( | pFaces. | size() &&pFaces.size()[WEDGE][WEDGE][0] | ) |
Definition at line 410 of file readKivaGrid.H.
References cellShapes, Foam::degToRad(), forAllIter, nPatches, pFaces, points(), and Foam::tan().

| faceListList boundary | ( | nPatches | ) |
Referenced by fvMesh::addFvPatches(), Foam::checkProcMeshesOrdering(), Foam::correctContactAngle(), fvFieldDecomposer::decomposeFvSurfaceField(), fvFieldDecomposer::decomposeVolField(), fvMesh::delta(), cloudMass::execute(), cloudSurfaceArea::execute(), cloudVolume::execute(), forAll(), fvFieldDecomposer::fvFieldDecomposer(), anisotropic< SolidThermophysicalTransportModel >::kappa(), CoEulerDdtScheme< Type >::meshPhi(), localEulerDdtScheme< Type >::meshPhi(), SLTSDdtScheme< Type >::meshPhi(), steadyStateDdtScheme< Type >::meshPhi(), fvMesh::movePoints(), fvMesh::ownerBf(), nonConformalBoundary::ownerOrigBoundaryEdgeMeshEdge(), fvMesh::polyBFacePatches(), fvMesh::polyFacesBf(), anisotropic< SolidThermophysicalTransportModel >::qCorr(), and volPointInterpolation::volPointInterpolation().

| wordList patchNames | ( | nPatches | ) |
Referenced by polyBoundaryMesh::checkDefinition(), polyBoundaryMesh::patchSet(), Foam::preservePatchTypes(), patch::print(), patchInternalField::print(), and fvMeshSubset::setLargeCellSubset().

| wordList patchTypes | ( | nPatches | ) |
Referenced by age::execute(), forAll(), and searchableSurfaceList::writeStats().

| labelList pointLabels | ( | nPoints | , |
| - | 1 | ||
| ) |
Referenced by cellModel::centre(), cellModel::edges(), cellModel::faces(), forAll(), cellModel::mag(), surfaceFeatures::nearestSamples(), cell::points(), setSize(), globalMeshData::sharedPointGlobalLabels(), and globalMeshData::sharedPoints().

| forAll | ( | cellShapes | , |
| celli | |||
| ) |
Definition at line 486 of file readKivaGrid.H.
References cellShapes, and pointLabels().
Referenced by forAll(), if(), and setSize().


| forAll | ( | pointLabels | , |
| pointi | |||
| ) |
Definition at line 496 of file readKivaGrid.H.
References newPointi, pointLabels(), and points().

References cellShapes, forAll(), and pointLabels().
Referenced by DynamicList< T, SizeInc, SizeMult, SizeDiv >::append(), List< T >::append(), DynamicField< T, SizeInc, SizeMult, SizeDiv >::append(), PtrList< T >::append(), UPtrList< T >::append(), pairPotentialList::buildPotentials(), tetherPotentialList::buildPotentials(), CompactListList< scalar >::clone(), face::collapse(), CompactIOListBase< Container, IOContainer, CompactIOContainer, Type >::CompactIOListBase(), patchPatchDist::correct(), DimensionedField< Type, GeoMesh, PrimitiveField >::DimensionedField(), directions::directions(), cpuLoad::distribute(), DynamicList< T, SizeInc, SizeMult, SizeDiv >::erase(), processorFvPatchField< Type >::initEvaluate(), IOListBase< Container, IOContainer, Type >::IOListBase(), Field< tensor >::map(), cpuLoad::mapMesh(), List< T >::newElmt(), DynamicList< T, SizeInc, SizeMult, SizeDiv >::operator()(), DynamicField< T, SizeInc, SizeMult, SizeDiv >::operator()(), Field< tensor >::operator/=(), DynamicList< Foam::List >::operator=(), PackedBoolList::operator=(), PtrList< T >::operator=(), DynamicField< scalar >::operator=(), ReactionList< Foam::sutherlandTransport >::ReactionList(), ReactionList< ThermoType >::ReactionList(), sampledSets::read(), sampledSurfaces::read(), zoneGeneratorList::read(), PtrList< T >::read(), GeometricBoundaryField< Type, GeoMesh, PrimitiveField >::readField(), PackedList< nBits >::reserve(), MRFZoneList::reset(), porosityModelList::reset(), GeometricBoundaryField< Type, GeoMesh, PrimitiveField >::reset(), CompactListList< T >::resize(), List< T >::resize(), PtrList< T >::resize(), UPtrList< T >::resize(), DynamicField< T, SizeInc, SizeMult, SizeDiv >::resize(), CompactListList< scalar >::resize(), PackedList< nBits >::setCapacity(), SquareMatrix< Type >::setSize(), List< T >::setSize(), PackedList< nBits >::shrink(), and ParSortableList< Type >::sort().


Definition at line 518 of file readKivaGrid.H.
References boundary(), f(), forAll(), patchi, and pointLabels().

| preservePatchTypes | ( | runTime | , |
| runTime. | constant(), | ||
| polyMesh::meshSubDir | , | ||
| patchNames | , | ||
| patchDicts | , | ||
| defaultFacesName | , | ||
| defaultFacesType | |||
| ) |
| forAll | ( | patchNames | , |
| patchi | |||
| ) |
Definition at line 543 of file readKivaGrid.H.
References patchDicts, patchi, and patchTypes().

| polyMesh pShapeMesh | ( | IOobject(polyMesh::defaultRegion, runTime.constant(), runTime) | , |
| move(points) | , | ||
| cellShapes | , | ||
| boundary | , | ||
| patchNames | , | ||
| patchDicts | , | ||
| defaultFacesName | , | ||
| defaultFacesType | |||
| ) |
| polyMeshUnMergeCyclics | ( | pShapeMesh | ) |
| 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.
| label i4 |
Definition at line 20 of file readKivaGrid.H.
Referenced by for().
| kivaFile mTable |
Definition at line 68 of file readKivaGrid.H.
| 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, &mergedCyclicPolyPatch::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 229 of file readKivaGrid.H.
Referenced by singleProcessorFaceSetsConstraint::add(), singleProcessorFaceSetsConstraint::apply(), snappySnapDriver::avgCellCentres(), Foam::meshTools::calcBoxPointNormals(), polyMeshTetDecomposition::cellTetIndices(), PrimitivePatch< FaceList, PointField >::checkPointManifold(), decompositionMethod::decompose(), polyMeshTetDecomposition::faceTetIndices(), cellClassification::fillRegionPoints(), polyMeshTetDecomposition::findBasePoint(), localPointRegion::findDuplicateFaces(), polyMeshTetDecomposition::findSharedBasePoint(), polyMeshTetDecomposition::findTet(), cellLooper::getVertFacesNonEdge(), treeDataFace::getVolumeType(), if(), volPointInterpolation::interpolateUnconstrained(), primitiveMesh::pointCells(), PatchTools::pointNormals(), Foam::polyMeshZipUpCells(), removePoints::setRefinement(), perfectInterface::setRefinement(), hexRef8::setUnrefinement(), meshRefinement::splitMesh(), triSurfaceTools::trackToEdge(), and volPointInterpolation::volPointInterpolation().
| label nPatches = 0 |
Definition at line 396 of file readKivaGrid.H.
Referenced by addPatchCellLayer::calcSidePatch(), PointEdgeWave< Type, TrackingData >::countPatchType(), if(), LocalInteraction< CloudType >::info(), STARCD::readBoundary(), polyTopoChange::setNumPatches(), USERD_get_gold_part_build_info(), USERD_get_gold_variable_info(), USERD_get_nfaced_conn(), USERD_get_nfaced_nodes_per_face(), USERD_get_nsided_conn(), USERD_get_part_coords(), USERD_get_part_element_ids_by_type(), USERD_get_part_elements_by_type(), USERD_get_part_node_ids(), USERD_get_var_by_component(), USERD_set_filenames(), and USERD_set_time_set_and_step().
| word defaultFacesName = "defaultFaces" |
Definition at line 454 of file readKivaGrid.H.
Referenced by Foam::preservePatchTypes().
| word defaultFacesType = emptyPolyPatch::typeName |
Definition at line 455 of file readKivaGrid.H.
Referenced by Foam::preservePatchTypes().
| label nAddedPatches = 0 |
Definition at line 457 of file readKivaGrid.H.
| label newPointi = 0 |
Definition at line 495 of file readKivaGrid.H.
Referenced by extendedEdgeMesh::add(), extendedEdgeMesh::flipNormals(), forAll(), triSurfaceTools::greenRefine(), hexRef8::subset(), localPointRegion::topoChange(), polyMesh::topoChange(), addPatchCellLayer::topoChange(), hexRef8::topoChange(), pointZoneSet::topoChange(), and triSurfaceTools::triangulateFaceCentre().
| PtrList<dictionary> patchDicts |
Definition at line 531 of file readKivaGrid.H.
Referenced by forAll(), and Foam::preservePatchTypes().