Overture
Version 25
|
#include "ExposedPoints.h"
#include "OGFunction.h"
#include "InterpolatePoints.h"
#include "display.h"
#include "HDF_DataBase.h"
#include "ParallelUtility.h"
#include "InterpolatePointsOnAGrid.h"
Macros | |
#define | FOR_3D(i1, i2, i3, I1, I2, I3) int I1Base =I1.getBase(), I2Base =I2.getBase(), I3Base =I3.getBase(); int I1Bound=I1.getBound(), I2Bound=I2.getBound(), I3Bound=I3.getBound(); for(i3=I3Base; i3<=I3Bound; i3++) for(i2=I2Base; i2<=I2Bound; i2++) for(i1=I1Base; i1<=I1Bound; i1++) |
#define | FOR_3(i1, i2, i3, I1, I2, I3) I1Base =I1.getBase(), I2Base =I2.getBase(), I3Base =I3.getBase(); I1Bound=I1.getBound(), I2Bound=I2.getBound(), I3Bound=I3.getBound(); for(i3=I3Base; i3<=I3Bound; i3++) for(i2=I2Base; i2<=I2Bound; i2++) for(i1=I1Base; i1<=I1Bound; i1++) |
#define | FOR_2D(i1, i2, I1, I2) int I1Base =I1.getBase(), I2Base =I2.getBase(); int I1Bound=I1.getBound(), I2Bound=I2.getBound(); for(i2=I2Base; i2<=I2Bound; i2++) for(i1=I1Base; i1<=I1Bound; i1++) |
#define | XY(i1, i2, i3) center(i1,i2,i3,axis1),center(i1,i2,i3,axis2) |
#define | XYZ(i1, i2, i3) center(i1,i2,i3,axis1),center(i1,i2,i3,axis2),center(i1,i2,i3,axis3) |
#define | indexRange(i0, i1) indexRangep[i0+indexRangeDim0*(i1)] |
#define | extendedIndexRange(i0, i1) extendedIndexRangep[i0+extendedIndexRangeDim0*(i1)] |
#define | boundaryCondition(i0, i1) boundaryConditionp[i0+boundaryConditionDim0*(i1)] |
#define | MASK2(i0, i1, i2) mask2p[i0+mask2Dim0*(i1+mask2Dim1*(i2))] |
#define | gridSpacing(i0) gridSpacingp[i0] |
#define | MASK2D(k1, k2, k3) (MASK2(k1,k2,k3)>0 ? 1 : MASK2(k1,k2,k3)==0 ? 0 : -1) |
#define | MASK2_W5A(k1, k2, k3) MASK2(k1,k2,k3)!=0 && MASK2(k1+1,k2,k3)!=0 && MASK2(k1+2,k2,k3)!=0 && MASK2(k1+3,k2,k3)!=0 && MASK2(k1+4,k2,k3)!=0 |
#define | MASK2_W5B(k1, k2, k3) MASK2_W5A(k1,k2,k3) && MASK2_W5A(k1,k2+1,k3) && MASK2_W5A(k1,k2+2,k3) && MASK2_W5A(k1,k2+3,k3) && MASK2_W5A(k1,k2+4,k3) |
#define | MASK2_W5C(k1, k2, k3) MASK2_W5B(k1,k2,k3) && MASK2_W5B(k1,k2,k3+1) && MASK2_W5B(k1,k2,k3+2) && MASK2_W5B(k1,k2,k3+3) && MASK2_W5B(k1,k2,k3+4) |
#define | MASK2_W4A(k1, k2, k3) MASK2(k1,k2,k3)!=0 && MASK2(k1+1,k2,k3)!=0 && MASK2(k1+2,k2,k3)!=0 && MASK2(k1+3,k2,k3)!=0 |
#define | MASK2_W4B(k1, k2, k3) MASK2_W4A(k1,k2,k3) && MASK2_W4A(k1,k2+1,k3) && MASK2_W4A(k1,k2+2,k3) && MASK2_W4A(k1,k2+3,k3) |
#define | MASK2_W4C(k1, k2, k3) MASK2_W4B(k1,k2,k3) && MASK2_W4B(k1,k2,k3+1) && MASK2_W4B(k1,k2,k3+2) && MASK2_W4B(k1,k2,k3+3) |
#define | gid(side, axis) gid_[(side)+2*(axis)] |
#define | ia(i0) iap[i0] |
#define | ip(i0, i1) ipp[i0+ipDim0*(i1)] |
#define | interpoleeLocation(i0, i1) interpoleeLocationp[i0+interpoleeLocationDim0*(i1)] |
#define | variableInterpolationWidth(i0) variableInterpolationWidthp[i0] |
#define | interpoleeGrid(i0, i1) interpoleeGridp[i0+interpoleeGridDim0*(i1)] |
#define | interpolationCoordinates(i0, i1) interpolationCoordinatesp[i0+interpolationCoordinatesDim0*(i1)] |
#define | uInterpolated(i0, i1) uInterpolatedp[i0+uInterpolatedDim0*(i1)] |
#define | UG(i0, i1, i2) ugp[i0+ugDim0*(i1+ugDim1*(i2))] |
#define | Q31(i1, i2, i3) ( .5*(1.-dr0)*(2.-dr0)*UG(i1 ,i2,c0)+dr0 *(2.-dr0)*UG(i1+1,i2,c0)-.5*(1.-dr0)* dr0 *UG(i1+2,i2,c0) ) |
#define | Q32(i1, i2, i3) (.5*(1.-dr1)*(2.-dr1)*Q31(i1,i2 ,i3) + dr1 *(2.-dr1)*Q31(i1,i2+1,i3) -.5*(1.-dr1)* dr1 *Q31(i1,i2+2,i3)) |
#define | Q33(i1, i2, i3) (.5*(1.-dr2)*(2.-dr2)*Q32(i1,i2,i3 ) + dr2 *(2.-dr2)*Q32(i1,i2,i3+1) -.5*(1.-dr2)* dr2 *Q32(i1,i2,i3+2)) |
#define | UG(i0, i1, i2, i3) ugp[i0+ugDim0*(i1+ugDim1*(i2+ugDim2*(i3)))] |
#define | Q31(i1, i2, i3) ( .5*(1.-dr0)*(2.-dr0)*UG(i1 ,i2,i3,c0)+dr0*(2.-dr0)*UG(i1+1,i2,i3,c0)-.5*(1.-dr0)* dr0 *UG(i1+2,i2,i3,c0) ) |
#define | ia(i0, i1) iap[i0+iaDim0*(i1)] |
#define | mask1(i0, i1, i2) mask1p[i0+mask1Dim0*(i1+mask1Dim1*(i2))] |
#define | mask2(i0, i1, i2) mask2p[i0+mask2Dim0*(i1+mask2Dim1*(i2))] |
#define | interpoleeGrid(i0) interpoleeGridp[i0] |
#define | ip(i0, i1) ipp[i0+ipDim0*(i1)] |
#define | saveMask(i0) saveMaskp[i0] |
#define | minmax1(i1) max(n1a,min(n1b,i1)) |
#define | minmax2(i2) max(n2a,min(n2b,i2)) |
#define | minmax3(i3) max(n3a,min(n3b,i3)) |
#define | MASK5(i2z) mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
#define | MASKIN() (mask1(i1m1,i2m1,i3)<0 || mask1(i1 ,i2m1,i3)<0 || mask1(i1p1,i2m1,i3)<0 || mask1(i1m1,i2 ,i3)<0 || mask1(i1p1,i2 ,i3)<0 || mask1(i1m1,i2p1,i3)<0 || mask1(i1 ,i2p1,i3)<0 || mask1(i1p1,i2p1,i3)<0) |
#define | MASK5(i2z) mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
#define | MASK5(i2z, i3z) mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
#define | MASK55(i3z) MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
#define | MASKIN() ( mask1(i1m1,i2m1,i3m1)<0 || mask1(i1 ,i2m1,i3m1)<0 || mask1(i1p1,i2m1,i3m1)<0 || mask1(i1m1,i2 ,i3m1)<0 || mask1(i1 ,i2 ,i3m1)<0 || mask1(i1p1,i2 ,i3m1)<0 || mask1(i1m1,i2p1,i3m1)<0 || mask1(i1 ,i2p1,i3m1)<0 || mask1(i1p1,i2p1,i3m1)<0 || mask1(i1m1,i2m1,i3 )<0 || mask1(i1 ,i2m1,i3 )<0 || mask1(i1p1,i2m1,i3 )<0 || mask1(i1m1,i2 ,i3 )<0 || mask1(i1p1,i2 ,i3 )<0 || mask1(i1m1,i2p1,i3 )<0 || mask1(i1 ,i2p1,i3 )<0 || mask1(i1p1,i2p1,i3 )<0 || mask1(i1m1,i2m1,i3p1)<0 || mask1(i1 ,i2m1,i3p1)<0 || mask1(i1p1,i2m1,i3p1)<0 || mask1(i1m1,i2 ,i3p1)<0 || mask1(i1 ,i2 ,i3p1)<0 || mask1(i1p1,i2 ,i3p1)<0 || mask1(i1m1,i2p1,i3p1)<0 || mask1(i1 ,i2p1,i3p1)<0 || mask1(i1p1,i2p1,i3p1)<0 ) |
#define | MASK5(i2z, i3z) mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
#define | MASK55(i3z) MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
#define | MASK5(i2z) mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define | MASKIN() (mask1(i1m1,i2m1,i3)<0 || mask1(i1 ,i2m1,i3)<0 || mask1(i1p1,i2m1,i3)<0 || mask1(i1m1,i2 ,i3)<0 || mask1(i1p1,i2 ,i3)<0 || mask1(i1m1,i2p1,i3)<0 || mask1(i1 ,i2p1,i3)<0 || mask1(i1p1,i2p1,i3)<0) |
#define | MASK5(i2z) mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define | MASK5(i2z, i3z) mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define | MASK55(i3z) MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
#define | MASKIN() ( mask1(i1m1,i2m1,i3m1)<0 || mask1(i1 ,i2m1,i3m1)<0 || mask1(i1p1,i2m1,i3m1)<0 || mask1(i1m1,i2 ,i3m1)<0 || mask1(i1 ,i2 ,i3m1)<0 || mask1(i1p1,i2 ,i3m1)<0 || mask1(i1m1,i2p1,i3m1)<0 || mask1(i1 ,i2p1,i3m1)<0 || mask1(i1p1,i2p1,i3m1)<0 || mask1(i1m1,i2m1,i3 )<0 || mask1(i1 ,i2m1,i3 )<0 || mask1(i1p1,i2m1,i3 )<0 || mask1(i1m1,i2 ,i3 )<0 || mask1(i1p1,i2 ,i3 )<0 || mask1(i1m1,i2p1,i3 )<0 || mask1(i1 ,i2p1,i3 )<0 || mask1(i1p1,i2p1,i3 )<0 || mask1(i1m1,i2m1,i3p1)<0 || mask1(i1 ,i2m1,i3p1)<0 || mask1(i1p1,i2m1,i3p1)<0 || mask1(i1m1,i2 ,i3p1)<0 || mask1(i1 ,i2 ,i3p1)<0 || mask1(i1p1,i2 ,i3p1)<0 || mask1(i1m1,i2p1,i3p1)<0 || mask1(i1 ,i2p1,i3p1)<0 || mask1(i1p1,i2p1,i3p1)<0 ) |
#define | MASK5(i2z, i3z) mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define | MASK55(i3z) MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
#define | x(i0, i1) xp[i0+xDim0*(i1)] |
#define | COORD0(i0, i1, i2) (xa+dx0*(i0-i0a)) |
#define | COORD1(i0, i1, i2) (ya+dy0*(i1-i1a)) |
#define | COORD2(i0, i1, i2) (za+dz0*(i2-i2a)) |
#define | center(i0, i1, i2, i3) centerp[i0+centerDim0*(i1+centerDim1*(i2+centerDim2*(i3)))] |
#define | interpoleeGrid(i0) interpoleeGridp[i0] |
#define | bb(side, axis) bbp[side+2*(axis)] |
#define | interpoleeGrid(i0) interpoleeGridp[i0] |
#define | mask1(i0, i1, i2) mask1p[i0+mask1Dim0*(i1+mask1Dim1*(i2))] |
#define | mask1(i0, i1, i2) mask1p[i0+mask1Dim0*(i1+mask1Dim1*(i2))] |
#define | ip(i0, i1) ipp[i0+ipDim0*(i1)] |
#define | saveMask(i0) saveMaskp[i0] |
#define | ia(i0, i1) iap[i0+iaDim0*(i1)] |
#define | UI(i0, i1) uip[i0+uiDim0*(i1)] |
#define | x(i0, i1) xp[i0+xDim0*(i1)] |
#define | u1g(i0, i1, i2, i3) u1gp[i0+u1gDim0*(i1+u1gDim1*(i2+u1gDim2*(i3)))] |
#define bb | ( | side, | |
axis | |||
) | bbp[side+2*(axis)] |
Referenced by HyperbolicMapping::addBoundaryCurves(), CompositeTopology::buildEdgeCurveSearchTree(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), UnstructuredMapping::buildSearchTree(), CompositeTopology::buildSubSurfaceTriangulation(), Ogen::classifyPoints(), DistributedInverse::computeBoundingBoxes(), CompositeTopology::findBoundaryCurves(), UnstructuredMapping::findClosestEntity(), Mapping::findNearestGridPoint(), InterpolatePointsOnAGrid::findNearestValidGridPoint(), findNearestValidGridPoint(), GeometricADT< dataT >addElement(), Regrid::getBoundedBox(), SquareMapping::getBoundingBox(), BoxMapping::getBoundingBox(), ReparameterizationTransform::getBoundingBox(), CompositeTopology::getNearestEdge(), ExposedPoints::initialize(), ApproximateGlobalInverse::initialize(), UnstructuredMapping::insideOrOutside(), Mapping::inverseMapS(), CompositeTopology::joinEdgeCurves(), UserDefinedMapping1::mapS(), CompositeTopology::merge(), UnstructuredMapping::project(), UnstructuredMapping::projectOnTriangle(), spewPrimitiveEPS(), CompositeTopology::splitAndMergeEdgeCurves(), CompositeTopology::splitEdge(), and FilamentMapping::update().
#define boundaryCondition | ( | i0, | |
i1 | |||
) | boundaryConditionp[i0+boundaryConditionDim0*(i1)] |
Referenced by Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), Ogen::canDiscretize(), DerivedFunctions::computeDerivedFunctions(), Integrate::computeSurfaceWeights(), PlotIt::contour2d(), PlotIt::contour3d(), PlotIt::contourCuts(), Ogen::displayCompositeGridParameters(), GenericMappedGridOperators::fixBoundaryCorners(), ExposedPoints::getInterpolationStencil(), PlotIt::grid3d(), Ogen::isNeededForDiscretization(), Ogen::isOnInterpolationBoundary(), main(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), PlotIt::plotGrid(), PlotIt::plotGridBoundaries(), MappedGridData::put(), RevolutionMapping::setParameterAxes(), PlotIt::streamLines2d(), Integrate::surfaceIntegral(), and FileOutput::update().
Referenced by Ogen::adjustForNearbyBoundaries(), ArrayUtil::assignGridFunction(), assignGridFunction(), Ogen::buildCutout(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), Ogen::checkForOrphanPointsOnBoundaries(), Ogen::checkHoleCutting(), Ogen::checkInterpolationOnBoundaries(), Ogen::classifyPoints(), AdvancingFront::computeFaceNormal(), Integrate::computeWeights(), PlotIt::contourOpt2d(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), SurfaceStitcher::enlargeGapWidth(), Ogen::findClosestBoundaryPoint(), Ugen::generateSpacingControlMesh(), Ogmg::getInterpolationCoordinates(), Ogmg::getInterpolationCoordinatesNew(), Ogmg::getInterpolationCoordinatesNewOld(), CopyArray::getLocalArrayBox(), PlotIt::grid3d(), ExposedPoints::initialize(), Ugen::initializeGeneration(), ExposedPoints::interpolate(), Ogen::interpolateAll(), InterpolatePoints::interpolateAllPoints(), InterpolatePointsOnAGrid::interpolateAllPoints(), interpolateAllPoints(), Ogen::interpolateAPoint(), interpolateExposedPoints(), interpolatePoints(), Ogen::interpolatePoints(), OGPolyFunction::laplacian(), Ogen::lastChanceInterpolation(), main(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), OGPolyFunction::operator()(), PlotIt::plotGrid(), PlotIt::plotGrid2d(), Ogen::preInterpolateGrids(), SweepMapping::put(), MappedGridData::put(), Ogen::queryAPoint(), Ogen::removeExteriorPointsNew(), Ogen::sweepOutHolePoints(), OGPolyFunction::t(), OGPolyFunction::x(), xInterpolate(), xInterpolateOpt(), OGPolyFunction::xx(), OGPolyFunction::xxx(), OGPolyFunction::xxxx(), OGPolyFunction::xy(), OGPolyFunction::xz(), OGPolyFunction::y(), OGPolyFunction::yy(), OGPolyFunction::yz(), OGPolyFunction::z(), and OGPolyFunction::zz().
#define COORD0 | ( | i0, | |
i1, | |||
i2 | |||
) | (xa+dx0*(i0-i0a)) |
#define COORD1 | ( | i0, | |
i1, | |||
i2 | |||
) | (ya+dy0*(i1-i1a)) |
#define extendedIndexRange | ( | i0, | |
i1 | |||
) | extendedIndexRangep[i0+extendedIndexRangeDim0*(i1)] |
Referenced by InterpolateRefinements::buildBaseBox(), Ogmg::buildExtraLevelsNew(), Ogen::canDiscretize(), Regrid::cellCenteredBaseBox(), PlotIt::contourOpt2d(), AssignInterpNeighbours::findInterpolationNeighbours(), GenericMappedGridOperators::findInterpolationNeighbours(), ExposedPoints::getInterpolationStencil(), Ogmg::getInterpolationStencil(), Ogen::isNeededForDiscretization(), Ogen::isOnInterpolationBoundary(), MappedGridData::put(), Ogmg::setMean(), and xInterpolateOpt().
#define FOR_2D | ( | i1, | |
i2, | |||
I1, | |||
I2 | |||
) | int I1Base =I1.getBase(), I2Base =I2.getBase(); int I1Bound=I1.getBound(), I2Bound=I2.getBound(); for(i2=I2Base; i2<=I2Bound; i2++) for(i1=I1Base; i1<=I1Bound; i1++) |
Referenced by ExposedPoints::initialize().
#define FOR_3 | ( | i1, | |
i2, | |||
i3, | |||
I1, | |||
I2, | |||
I3 | |||
) | I1Base =I1.getBase(), I2Base =I2.getBase(), I3Base =I3.getBase(); I1Bound=I1.getBound(), I2Bound=I2.getBound(), I3Bound=I3.getBound(); for(i3=I3Base; i3<=I3Bound; i3++) for(i2=I2Base; i2<=I2Bound; i2++) for(i1=I1Base; i1<=I1Bound; i1++) |
#define FOR_3D | ( | i1, | |
i2, | |||
i3, | |||
I1, | |||
I2, | |||
I3 | |||
) | int I1Base =I1.getBase(), I2Base =I2.getBase(), I3Base =I3.getBase(); int I1Bound=I1.getBound(), I2Bound=I2.getBound(), I3Bound=I3.getBound(); for(i3=I3Base; i3<=I3Bound; i3++) for(i2=I2Base; i2<=I2Bound; i2++) for(i1=I1Base; i1<=I1Bound; i1++) |
#define gid | ( | side, | |
axis | |||
) | gid_[(side)+2*(axis)] |
Referenced by InterpolateRefinements::boxWasAdjustedInPeriodicDirection(), Regrid::buildGrids(), CanInterpolate::canInterpolate(), CanInterpolate::canInterpolateOld(), Ogen::checkUpdateRefinement(), OgmgParameters::chooseGoodMultigridParameters(), Integrate::computeStitchedSurfaceWeightsOld(), Ogmg::defectNorm(), ApproximateGlobalInverse::findNearestGridPoint(), Mapping::findNearestGridPoint(), floatMappedGridFunction::fixupUnusedPoints(), doubleMappedGridFunction::fixupUnusedPoints(), intMappedGridFunction::fixupUnusedPoints(), HyperbolicMapping::generate(), Mapping::getBoundingBox(), GridStatistics::getGridSpacing(), ExposedPoints::initialize(), InterpolatePoints::interpolatePoints(), ExposedPoints::interpolatePoints(), InterpolatePoints::interpolationCoefficients(), Ogmg::l2Error(), l2Norm(), Ogmg::l2Norm(), lpNorm(), maxNorm(), Ogmg::maxNorm(), GridStatistics::printGridStatistics(), printGridStatistics(), printInfo(), Regrid::regridRotated(), saveOvertureTextFile(), Regrid::setupCoarseIndexSpace(), showFileFromDataFile(), Ogmg::smoothInterpolationNeighbours(), Ogmg::smoothLine(), Ogmg::smoothRedBlack(), HyperbolicMapping::update(), HyperbolicMapping::updateMarchingParameters(), and HyperbolicMapping::updateOld().
#define gridSpacing | ( | i0 | ) | gridSpacingp[i0] |
Referenced by Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), CanInterpolate::canInterpolate(), CanInterpolate::canInterpolateOld(), Integrate::computeStitchedSurfaceWeights(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), Integrate::computeWeights(), EllipticGridGenerator::defineSurfaceControlFunction(), dudt(), ExposedPoints::getInterpolationStencil(), Ogmg::getInterpolationStencil(), getTimeStep(), interpolatePoints(), main(), MappedGridData::put(), and Ogen::updateCanInterpolate().
#define ia | ( | i0 | ) | iap[i0] |
Referenced by Ogen::adjustBoundary(), Ogen::adjustForNearbyBoundaries(), MappedGridOperators::applyBoundaryCondition(), Ogmg::applyBoundaryConditions(), AssignInterpNeighbours::assign(), TrimmedMapping::basicInverse(), DataPointMapping::basicInverseS(), Ogen::buildCutout(), Ogmg::buildExtraLevels(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), NurbsMapping::buildSubCurves(), UnstructuredMapping::buildUnstructuredGrid(), Ogen::checkHoleCutting(), Ogen::checkInterpolationOnBoundaries(), checkOverlappingGrid(), Ogen::classifyPoints(), PlotIt::contourOpt2d(), CompositeGridData::convertLocalInterpolationData(), CopyArray::copyArray(), MappingsFromCAD::createCurveOnAParametricSurface(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), Ogmg::defectNorm(), GridCollection::deleteGrid(), CompositeGrid::deleteGrid(), Ogen::determineMinimalIndexRange(), ApproximateGlobalInverse::distanceToCell(), SurfaceStitcher::enlargeGapWidth(), Ogen::explicitHoleCutting(), AssignInterpNeighbours::findInterpolationNeighbours(), GenericMappedGridOperators::findInterpolationNeighbours(), ApproximateGlobalInverse::findNearestCell(), InterpolatePointsOnAGrid::findNearestValidGridPoint(), findNearestValidGridPoint(), Ugen::generateHoleLists(), Ogen::generateInterpolationArrays(), Ogmg::getDefect(), UnstructuredMapping::getElementFaceNodes(), Ogmg::getInterpolationCoordinates(), InterpolatePoints::getInterpolationInfo(), InterpolatePointsOnAGrid::getInterpolationInfo(), CopyArray::getLocalArrayBox(), getLocalBounds(), Ogen::improveQuality(), ExposedPoints::initialize(), JoinMapping::initialize(), InterpolatePointsOnAGrid::internalInterpolate(), ExposedPoints::interpolate(), Ogen::interpolateAll(), InterpolatePoints::interpolateAllPoints(), InterpolatePointsOnAGrid::interpolateAllPoints(), Ogen::interpolateAPoint(), interpolateExposedPoints(), Ogen::interpolateMixedBoundary(), InterpolatePoints::interpolatePoints(), InterpolatePoints::interpolationCoefficients(), IndexBox::intersect(), CrossSectionMapping::mapGeneral(), CrossSectionMapping::mapGeneralWithPolarSingularity(), Mapping::mapGrid(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), Ogmg::operatorAveraging(), InterpolatePointsOnAGrid::parallelSetup(), GenericGraphicsInterface::parseAnswer(), Ogen::plot(), ErrorEstimator::plotErrorPoints(), PlotIt::plotGrid2d(), Ogen::preInterpolateGrids(), Ogen::removeExteriorPoints(), CompositeGrid::setHybridConnectivity(), Oges::sizeOf(), Ogmg::smoothLine(), Ogen::updateBoundaryAdjustment(), Ogen::updateCanInterpolate(), and Ogen::updateRefinementFillInterpolationData().
#define ia | ( | i0, | |
i1 | |||
) | iap[i0+iaDim0*(i1)] |
#define ia | ( | i0, | |
i1 | |||
) | iap[i0+iaDim0*(i1)] |
#define indexRange | ( | i0, | |
i1 | |||
) | indexRangep[i0+indexRangeDim0*(i1)] |
Referenced by Ogmg::buildExtraLevels(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), checkGrid(), DerivedFunctions::computeDerivedFunctions(), PlotIt::contour3d(), Ogen::determineMinimalIndexRange(), equiGridSmoother(), GenericMappedGridOperators::findInterpolationNeighbours(), GenericMappedGridOperators::finishBoundaryConditions(), GenericMappedGridOperators::fixBoundaryCorners(), SquareMapping::getBoundingBox(), BoxMapping::getBoundingBox(), ReparameterizationTransform::getBoundingBox(), Mapping::getBoundingBox(), PlotIt::getBounds(), getError(), ExposedPoints::getInterpolationStencil(), Ogmg::getInterpolationStencil(), ParallelGridUtility::getLocalIndexBoundsAndBoundaryConditions(), interpolatePoints(), interpolateRefinements(), main(), intMappedGridFunction::periodicUpdate(), doubleMappedGridFunction::periodicUpdate(), floatMappedGridFunction::periodicUpdate(), PlotIt::plotGrid(), MappedGridData::put(), GridSmoother::smooth(), Interpolant::testInterpolation(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), Ogen::updateRefinementNew(), and xInterpolate().
#define interpolationCoordinates | ( | i0, | |
i1 | |||
) | interpolationCoordinatesp[i0+interpolationCoordinatesDim0*(i1)] |
Referenced by Ogmg::buildExtraLevels(), Ogen::generateInterpolationArrays(), ExposedPoints::interpolatePoints(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), CompositeGridData::put(), CompositeGrid::sizeOf(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), and Ogen::updateRefinementNew().
#define interpoleeGrid | ( | i0, | |
i1 | |||
) | interpoleeGridp[i0+interpoleeGridDim0*(i1)] |
Referenced by Ogmg::buildExtraLevels(), Ogen::checkRefinementInterpolation(), Ogen::checkRefinementInterpolationNew(), Integrate::computeStitchedSurfaceWeights(), Integrate::computeStitchedSurfaceWeightsOld(), displayValuesAtAPoint(), Ogen::generateInterpolationArrays(), InterpolatePoints::getInterpolationInfo(), InterpolatePointsOnAGrid::getInterpolationInfo(), PlotIt::grid3d(), ExposedPoints::initialize(), interpolateExposedPoints(), interpolatePoints(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), PlotIt::plotGrid2d(), CompositeGridData::put(), CompositeGrid::sizeOf(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), and Ogen::updateRefinementNew().
#define interpoleeGrid | ( | i0 | ) | interpoleeGridp[i0] |
#define interpoleeGrid | ( | i0 | ) | interpoleeGridp[i0] |
#define interpoleeGrid | ( | i0 | ) | interpoleeGridp[i0] |
#define interpoleeLocation | ( | i0, | |
i1 | |||
) | interpoleeLocationp[i0+interpoleeLocationDim0*(i1)] |
Referenced by Ogmg::buildExtraLevels(), Ogen::generateInterpolationArrays(), ExposedPoints::interpolatePoints(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), CompositeGridData::put(), CompositeGrid::sizeOf(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), and Ogen::updateRefinementNew().
#define ip | ( | i0, | |
i1 | |||
) | ipp[i0+ipDim0*(i1)] |
Referenced by ParallelOverlappingGridInterpolator::bruteForceInterpolate(), CompositeTopology::buildEdgeSegment(), Ogmg::buildExtraLevelsNew(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), Ogen::checkInterpolationOnBoundaries(), checkOverlappingGrid(), Ogen::checkRefinementInterpolation(), Ogen::checkRefinementInterpolationNew(), collectInterpolationData(), DataPointMapping::computeGhostPoints(), CompositeGridData::convertLocalInterpolationData(), AssignInterpNeighbours::findInterpolationNeighbours(), GenericMappedGridOperators::findInterpolationNeighbours(), Mapping::findNearestGridPoint(), Ogmg::fineToCoarseTest(), InterpolatePoints::getInterpolationInfo(), InterpolatePointsOnAGrid::getInterpolationInfo(), ParallelGridUtility::getLocalInterpolationData(), getNormal(), LoftedSurfaceMapping::getParameters(), UserDefinedMapping1::getParameters(), PlotIt::grid3d(), ExposedPoints::initialize(), InterpolatePointsOnAGrid::initializeExplicitInterpolation(), InterpolatePointsOnAGrid::internalInterpolate(), Ogmg::interpolate(), InterpolatePoints::interpolatePoints(), interpolatePoints(), InterpolatePoints::interpolationCoefficients(), Mapping::inverseMapS(), main(), DataPointMapping::mapS(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), ogen(), CompositeGridData::operator=(), PlotIt::plot(), PlotIt::plotGrid(), PlotIt::plotGrid2d(), GL_GraphicsInterface::plotPoints(), CompositeGrid::setHybridConnectivity(), Ogmg::smoothBoundary(), Ogmg::smoothInterpolationNeighbours(), Ogmg::smoothJacobi(), Ogmg::smoothLine(), CanInterpolate::transferInterpDataForAMR(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), Ogen::updateRefinementNew(), Ogen::updateRefinementNewer(), DataFormats::writePlot3d(), xInterpolate(), and xInterpolateOpt().
#define ip | ( | i0, | |
i1 | |||
) | ipp[i0+ipDim0*(i1)] |
#define ip | ( | i0, | |
i1 | |||
) | ipp[i0+ipDim0*(i1)] |
Referenced by DataPointMapping::basicInverseS(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), Ogen::checkForBoundaryAdjustments(), Ogen::countCrossingsWithRealBoundary(), IntersectionMapping::determineIntersection(), Ogen::getAdjustmentVectors(), ExposedPoints::initialize(), interpolateExposedPoints(), and Ogen::updateBoundaryAdjustment().
Referenced by DataPointMapping::basicInverseS(), Ogen::checkUpdateRefinement(), Ogen::countCrossingsWithRealBoundary(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), IntersectionMapping::determineIntersection(), SurfaceStitcher::enlargeGap(), SurfaceStitcher::enlargeGapWidth(), ExposedPoints::getInterpolationStencil(), Ogmg::getInterpolationStencil(), ExposedPoints::initialize(), Ogen::interpolateAPoint(), InterpolateRefinements::interpolateCoarseFromFine(), interpolateExposedPoints(), interpolateRefinements(), Ogen::lastChanceInterpolation(), Ogen::markPointsNeededForInterpolation(), Ogen::markPointsReallyNeededForInterpolation(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), DataFormats::readPlot3d(), and Ogmg::smoothInterpolationNeighbours().
#define MASK2_W4A | ( | k1, | |
k2, | |||
k3 | |||
) | MASK2(k1,k2,k3)!=0 && MASK2(k1+1,k2,k3)!=0 && MASK2(k1+2,k2,k3)!=0 && MASK2(k1+3,k2,k3)!=0 |
#define MASK2_W4B | ( | k1, | |
k2, | |||
k3 | |||
) | MASK2_W4A(k1,k2,k3) && MASK2_W4A(k1,k2+1,k3) && MASK2_W4A(k1,k2+2,k3) && MASK2_W4A(k1,k2+3,k3) |
Referenced by ExposedPoints::getInterpolationStencil(), and Ogmg::getInterpolationStencil().
#define MASK2_W4C | ( | k1, | |
k2, | |||
k3 | |||
) | MASK2_W4B(k1,k2,k3) && MASK2_W4B(k1,k2,k3+1) && MASK2_W4B(k1,k2,k3+2) && MASK2_W4B(k1,k2,k3+3) |
Referenced by ExposedPoints::getInterpolationStencil(), and Ogmg::getInterpolationStencil().
#define MASK2_W5A | ( | k1, | |
k2, | |||
k3 | |||
) | MASK2(k1,k2,k3)!=0 && MASK2(k1+1,k2,k3)!=0 && MASK2(k1+2,k2,k3)!=0 && MASK2(k1+3,k2,k3)!=0 && MASK2(k1+4,k2,k3)!=0 |
#define MASK2_W5B | ( | k1, | |
k2, | |||
k3 | |||
) | MASK2_W5A(k1,k2,k3) && MASK2_W5A(k1,k2+1,k3) && MASK2_W5A(k1,k2+2,k3) && MASK2_W5A(k1,k2+3,k3) && MASK2_W5A(k1,k2+4,k3) |
Referenced by ExposedPoints::getInterpolationStencil(), and Ogmg::getInterpolationStencil().
#define MASK2_W5C | ( | k1, | |
k2, | |||
k3 | |||
) | MASK2_W5B(k1,k2,k3) && MASK2_W5B(k1,k2,k3+1) && MASK2_W5B(k1,k2,k3+2) && MASK2_W5B(k1,k2,k3+3) && MASK2_W5B(k1,k2,k3+4) |
Referenced by ExposedPoints::getInterpolationStencil(), and Ogmg::getInterpolationStencil().
Referenced by ExposedPoints::getInterpolationStencil(), and Ogmg::getInterpolationStencil().
#define MASK5 | ( | i2z | ) | mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
Referenced by ExposedPoints::initialize(), and interpolateExposedPoints().
#define MASK5 | ( | i2z | ) | mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
#define MASK5 | ( | i2z, | |
i3z | |||
) | mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
#define MASK5 | ( | i2z, | |
i3z | |||
) | mask2(i1m2,i2z,i3z) != 0 || mask2(i1m1,i2z,i3z) != 0 || mask2(i1z,i2z,i3z) != 0 || mask2(i1p1,i2z,i3z) != 0 || mask2(i1p2,i2z,i3z) != 0 |
#define MASK5 | ( | i2z | ) | mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define MASK5 | ( | i2z | ) | mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define MASK5 | ( | i2z, | |
i3z | |||
) | mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define MASK5 | ( | i2z, | |
i3z | |||
) | mask2(i1m2,i2z,i3z) > 0 || mask2(i1m1,i2z,i3z) > 0 || mask2(i1z,i2z,i3z) > 0 || mask2(i1p1,i2z,i3z) > 0 || mask2(i1p2,i2z,i3z) > 0 |
#define MASK55 | ( | i3z | ) | MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
Referenced by ExposedPoints::initialize(), and interpolateExposedPoints().
#define MASK55 | ( | i3z | ) | MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
#define MASK55 | ( | i3z | ) | MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
#define MASK55 | ( | i3z | ) | MASK5(i2m2,i3z) || MASK5(i2m1,i3z) || MASK5(i2z,i3z) || MASK5(i2p1,i3z) || MASK5(i2p2,i3z) |
#define MASKIN | ( | ) | (mask1(i1m1,i2m1,i3)<0 || mask1(i1 ,i2m1,i3)<0 || mask1(i1p1,i2m1,i3)<0 || mask1(i1m1,i2 ,i3)<0 || mask1(i1p1,i2 ,i3)<0 || mask1(i1m1,i2p1,i3)<0 || mask1(i1 ,i2p1,i3)<0 || mask1(i1p1,i2p1,i3)<0) |
Referenced by ExposedPoints::initialize().
#define MASKIN | ( | ) | ( mask1(i1m1,i2m1,i3m1)<0 || mask1(i1 ,i2m1,i3m1)<0 || mask1(i1p1,i2m1,i3m1)<0 || mask1(i1m1,i2 ,i3m1)<0 || mask1(i1 ,i2 ,i3m1)<0 || mask1(i1p1,i2 ,i3m1)<0 || mask1(i1m1,i2p1,i3m1)<0 || mask1(i1 ,i2p1,i3m1)<0 || mask1(i1p1,i2p1,i3m1)<0 || mask1(i1m1,i2m1,i3 )<0 || mask1(i1 ,i2m1,i3 )<0 || mask1(i1p1,i2m1,i3 )<0 || mask1(i1m1,i2 ,i3 )<0 || mask1(i1p1,i2 ,i3 )<0 || mask1(i1m1,i2p1,i3 )<0 || mask1(i1 ,i2p1,i3 )<0 || mask1(i1p1,i2p1,i3 )<0 || mask1(i1m1,i2m1,i3p1)<0 || mask1(i1 ,i2m1,i3p1)<0 || mask1(i1p1,i2m1,i3p1)<0 || mask1(i1m1,i2 ,i3p1)<0 || mask1(i1 ,i2 ,i3p1)<0 || mask1(i1p1,i2 ,i3p1)<0 || mask1(i1m1,i2p1,i3p1)<0 || mask1(i1 ,i2p1,i3p1)<0 || mask1(i1p1,i2p1,i3p1)<0 ) |
#define MASKIN | ( | ) | (mask1(i1m1,i2m1,i3)<0 || mask1(i1 ,i2m1,i3)<0 || mask1(i1p1,i2m1,i3)<0 || mask1(i1m1,i2 ,i3)<0 || mask1(i1p1,i2 ,i3)<0 || mask1(i1m1,i2p1,i3)<0 || mask1(i1 ,i2p1,i3)<0 || mask1(i1p1,i2p1,i3)<0) |
#define MASKIN | ( | ) | ( mask1(i1m1,i2m1,i3m1)<0 || mask1(i1 ,i2m1,i3m1)<0 || mask1(i1p1,i2m1,i3m1)<0 || mask1(i1m1,i2 ,i3m1)<0 || mask1(i1 ,i2 ,i3m1)<0 || mask1(i1p1,i2 ,i3m1)<0 || mask1(i1m1,i2p1,i3m1)<0 || mask1(i1 ,i2p1,i3m1)<0 || mask1(i1p1,i2p1,i3m1)<0 || mask1(i1m1,i2m1,i3 )<0 || mask1(i1 ,i2m1,i3 )<0 || mask1(i1p1,i2m1,i3 )<0 || mask1(i1m1,i2 ,i3 )<0 || mask1(i1p1,i2 ,i3 )<0 || mask1(i1m1,i2p1,i3 )<0 || mask1(i1 ,i2p1,i3 )<0 || mask1(i1p1,i2p1,i3 )<0 || mask1(i1m1,i2m1,i3p1)<0 || mask1(i1 ,i2m1,i3p1)<0 || mask1(i1p1,i2m1,i3p1)<0 || mask1(i1m1,i2 ,i3p1)<0 || mask1(i1 ,i2 ,i3p1)<0 || mask1(i1p1,i2 ,i3p1)<0 || mask1(i1m1,i2p1,i3p1)<0 || mask1(i1 ,i2p1,i3p1)<0 || mask1(i1p1,i2p1,i3p1)<0 ) |
Referenced by ExposedPoints::initialize().
Referenced by ExposedPoints::initialize().
Referenced by ExposedPoints::initialize().
#define Q31 | ( | i1, | |
i2, | |||
i3 | |||
) | ( .5*(1.-dr0)*(2.-dr0)*UG(i1 ,i2,c0)+dr0 *(2.-dr0)*UG(i1+1,i2,c0)-.5*(1.-dr0)* dr0 *UG(i1+2,i2,c0) ) |
#define Q31 | ( | i1, | |
i2, | |||
i3 | |||
) | ( .5*(1.-dr0)*(2.-dr0)*UG(i1 ,i2,i3,c0)+dr0*(2.-dr0)*UG(i1+1,i2,i3,c0)-.5*(1.-dr0)* dr0 *UG(i1+2,i2,i3,c0) ) |
#define Q33 | ( | i1, | |
i2, | |||
i3 | |||
) | (.5*(1.-dr2)*(2.-dr2)*Q32(i1,i2,i3 ) + dr2 *(2.-dr2)*Q32(i1,i2,i3+1) -.5*(1.-dr2)* dr2 *Q32(i1,i2,i3+2)) |
Referenced by ExposedPoints::interpolatePoints().
#define saveMask | ( | i0 | ) | saveMaskp[i0] |
Referenced by ExposedPoints::initialize().
#define saveMask | ( | i0 | ) | saveMaskp[i0] |
Referenced by ExposedPoints::interpolate(), interpolateExposedPoints(), main(), rungeKutta1(), rungeKutta2(), and rungeKutta4().
#define UI | ( | i0, | |
i1 | |||
) | uip[i0+uiDim0*(i1)] |
#define uInterpolated | ( | i0, | |
i1 | |||
) | uInterpolatedp[i0+uInterpolatedDim0*(i1)] |
#define variableInterpolationWidth | ( | i0 | ) | variableInterpolationWidthp[i0] |
Referenced by Ogmg::buildExtraLevels(), Ogen::generateInterpolationArrays(), GenericCompositeGridOperators::getInterpolationCoefficients(), ExposedPoints::interpolatePoints(), CompositeGridData::put(), CompositeGrid::sizeOf(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), and Ogen::updateRefinementNew().
#define x | ( | i0, | |
i1 | |||
) | xp[i0+xDim0*(i1)] |
Referenced by Ogen::adjustForNearbyBoundaries(), GL_GraphicsInterface::annotate(), MappedGridOperators::applyBCaDotGradU(), MappedGridOperators::applyBCGenDiv(), MappedGridOperators::applyBCneumann(), MappedGridOperators::applyBCnormalComponent(), MappedGridOperators::applyBCnormalDerivative(), MappedGridOperators::applyBCtangentialComponent(), applyMatrixTransform(), MappingBuilder::assignBoundaryConditions(), AnnulusMapping::basicInverse(), UserDefinedMapping1::bladeSetup(), GenericGrid::breakReference(), ParentChildSiblingInfo::breakReference(), GenericGridCollection::breakReference(), GridCollection::breakReference(), CompositeGrid::breakReference(), MappedGrid::breakReference(), MappingBuilder::buildBoxGrid(), Ogen::buildCutout(), CompositeTopology::buildEdgeCurveBoundaryNodes(), CompositeTopology::buildEdgeCurves(), buildEdgeCurves(), CompositeTopology::buildEdgeSegment(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), UnstructuredMapping::buildFromACompositeSurface(), UnstructuredMapping::buildFromAMapping(), UnstructuredMapping::buildFromARegularMapping(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), OffsetShell::buildOffsetMappings(), buildParameterCurveFromSpaceCurve(), MappingBuilder::buildSurfacePatch(), UnstructuredMapping::buildUnstructuredGrid(), Ogen::checkInterpolationOnBoundaries(), Mapping::checkMapping(), Ogen::checkRefinementInterpolation(), Ogen::checkRefinementInterpolationNew(), Ogen::classifyPoints(), closerSurfaceFound(), DistributedInverse::computeBoundingBoxes(), UnstructuredMapping::computeConnection(), DerivedFunctions::computeDerivedFunctions(), ErrorEstimator::computeErrorFunction(), ErrorEstimator::computeFunction(), MappingGeometry::computeVolumeIntegrals(), TrimmedMappingBuilder::constructOuterBoundaryCurves(), PlotIt::contour1d(), PlotIt::contour3d(), PlotIt::contourCuts(), PlotIt::contourOpt2d(), SmoothedPolygon::correctPolygonForCorners(), MappingsFromCAD::createCompositeCurve(), MappingsFromCAD::createCurveOnAParametricSurface(), HyperbolicMapping::createCurveOnSurface(), MappingsFromCAD::createSurface(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), MappedGridOperators::derivativeScalarDerivative(), MappedGridOperators::derivativeScalarDerivativeCoefficients(), IntersectionMapping::determineIntersection(), Mapping::determineResolution(), display(), TMquad::distancePointToSegment(), PlotIt::drawAStreamLine(), HyperbolicMapping::drawHyperbolicGrid(), equiGridSmoother(), CompositeTopology::findBoundaryCurves(), UnstructuredMapping::findBoundaryCurves(), HyperbolicMapping::findMatchingBoundaryCurve(), CompositeSurface::findNearbySurfaces(), HyperbolicMapping::findNormalsToStartCurve(), TFIMapping::flipper(), NurbsMapping::generalCylinder(), HyperbolicMapping::generate(), FilamentMapping::get(), get_circle_center(), Mapping::getArcLength(), GridStatistics::getGridSpacing(), Ogmg::getInterpolationCoordinates(), Ogmg::getInterpolationCoordinatesNew(), Ogmg::getInterpolationCoordinatesNewOld(), Triangle::getRelativeCoordinates(), getTrueSolution(), DerivedFunctions::getUserDefinedDerivedFunction(), GL_GraphicsInterface::hardCopy(), improveTriangulation(), ExposedPoints::initialize(), JoinMapping::initialize(), FilletMapping::initialize(), CrossSectionMapping::initialize(), ReparameterizationTransform::initializeEquidistribution(), FilamentMapping::initializeFilamentStorage(), ExposedPoints::interpolate(), Ogen::interpolateAll(), InterpolatePoints::interpolateAllPoints(), InterpolatePointsOnAGrid::interpolateAllPoints(), Ogen::interpolateAPoint(), interpolateExposedPoints(), Ogen::interpolateMixedBoundary(), interpolatePoints(), Ogen::interpolatePoints(), Triangle::intersects(), ExactLocalInverse::inverse(), Ogen::lastChanceInterpolation(), main(), SquareMapping::map(), SmoothedPolygon::map(), AnnulusMapping::map(), QuadraticMapping::map(), TFIMapping::map(), measureQuality(), CompositeTopology::merge(), NurbsMapping::merge(), CompositeTopology::mergeEdgeCurves(), NurbsMapping::moveEndpoint(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), GL_GraphicsInterface::normalizedToWorldCoordinates(), ogen(), Bound::operator real(), FilamentMapping::operator=(), GL_GraphicsInterface::pickToWorldCoordinates(), PlotIt::plotAdvancingFront(), HyperbolicMapping::plotCellQuality(), HyperbolicMapping::plotDirectionArrows(), ErrorEstimator::plotErrorPoints(), PlotIt::plotGrid(), PlotIt::plotGridQuality(), PlotIt::plotStructured(), PlotIt::plotSubSurfaceNormals(), Ogen::preInterpolateGrids(), GridStatistics::printGridStatistics(), printGridStatistics(), Ogen::printOrphanPoints(), GL_GraphicsInterface::processSpecialMenuItems(), LoftedSurfaceMapping::profileSetup(), DataPointMapping::projectGhostPoints(), Bound::put(), FilamentMapping::put(), Ogen::queryAPoint(), PlyFileInterface::readFile(), MappingsFromCAD::readFiniteElements(), NurbsMapping::readFromIgesFile(), MappingsFromCAD::readOneCurve(), DataFormats::readSTL(), refineTriangulation(), Ogen::removeExteriorPoints(), IntersectionMapping::reparameterize(), Stencil::rotate(), saveOvertureTextFile(), GL_GraphicsInterface::saveRasterInAFile(), Mapping::secondOrderDerivative(), SweepMapping::setMappingProperties(), DataPointMapping::setTopologyMask(), showFileFromDataFile(), GridSmoother::smooth(), HyperbolicMapping::smooth(), DataPointMapping::specifyTopology(), spewPrimitiveEPS(), CompositeTopology::splitAndMergeEdgeCurves(), CompositeTopology::splitEdge(), splitElement(), splitFace(), PlotIt::streamLines3d(), SmoothedPolygon::update(), RocketMapping::update(), CompositeTopology::update(), StretchTransform::update(), DepthMapping::update(), DataPointMapping::update(), RevolutionMapping::update(), GridStretcher::update(), CrossSectionMapping::update(), ReparameterizationTransform::update(), StretchMapping::update(), SplineMapping::update(), CompositeSurface::update(), HyperbolicMapping::update(), UnstructuredMapping::update(), Ogen::updateCanInterpolate(), HyperbolicMapping::updateMarchingParameters(), HyperbolicMapping::updateOld(), PlotIt::userDefinedOutput(), EllipticGridGenerator::weightFunction(), GL_GraphicsInterface::worldToNormalizedCoordinates(), DataFormats::writePlot3d(), xInterpolate(), xInterpolateOpt(), and GL_GraphicsInterface::xLabel().
#define x | ( | i0, | |
i1 | |||
) | xp[i0+xDim0*(i1)] |
Referenced by DataPointMapping::basicInverseS(), ExposedPoints::interpolate(), and DataPointMapping::mapScalar().