Overture  Version 25
Macros | Functions | Variables
arrayGetIndex.h File Reference
#include "GenericDataBase.h"
#include "A++.h"
#include "wdhdefs.h"
Include dependency graph for arrayGetIndex.h:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Macros

#define ARRAY_GET_INDEX_H   "arrayGetIndex.h"
 

Functions

void getIndex (const IntegerArray &indexArray, Index &I1, Index &I2, Index &I3, int extra1=0, int extra2=arrayGetIndexDefaultValue, int extra3=arrayGetIndexDefaultValue)
 
void getBoundaryIndex (const IntegerArray &indexArray, int side, int axis, Index &Ib1, Index &Ib2, Index &Ib3, int extra1=0, int extra2=arrayGetIndexDefaultValue, int extra3=arrayGetIndexDefaultValue)
 
void getGhostIndex (const IntegerArray &indexArray, int side, int axis, Index &Ib1, Index &Ib2, Index &Ib3, int ghostLine=1, int extra1=0, int extra2=arrayGetIndexDefaultValue, int extra3=arrayGetIndexDefaultValue)
 

Variables

const int arrayGetIndexDefaultValue =-999999
 

Macro Definition Documentation

#define ARRAY_GET_INDEX_H   "arrayGetIndex.h"

Function Documentation

void getBoundaryIndex ( const IntegerArray indexArray,
int  side,
int  axis,
Index &  Ib1,
Index &  Ib2,
Index &  Ib3,
int  extra1 = 0,
int  extra2 = arrayGetIndexDefaultValue,
int  extra3 = arrayGetIndexDefaultValue 
)

References arrayGetIndexDefaultValue, axis1, axis2, axis3, End, OGcheckIndex(), R, and Start.

Referenced by Ogen::adjustForNearbyBoundaries(), HyperbolicMapping::applyBoundaryConditionMatchToMapping(), GridSmoother::applyBoundaryConditions(), EllipticGridGenerator::applyBoundaryConditions(), HyperbolicMapping::applyBoundaryConditions(), Ogmg::applyInitialConditions(), Ogmg::assignBoundaryConditionCoefficients(), Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), SurfaceStitcher::buildSurfaceCompositeGrid(), Ogen::changeParameters(), Ogen::checkForOrphanPointsOnBoundaries(), checkGrid(), Ogen::checkInterpolationOnBoundaries(), checkOverlappingGrid(), Ogmg::coarseGridSolverTest(), Ogmg::coarseToFineTest(), DerivedFunctions::computeDerivedFunctions(), HyperbolicMapping::computeNonlinearDiffussionCoefficient(), Integrate::computeStitchedSurfaceWeights(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), Integrate::computeWeights(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), EllipticGridGenerator::defineBoundaryControlFunction(), EllipticGridGenerator::determineBoundarySpacing(), equiGridSmoother(), Ogmg::evaluateTheDefectFormula(), Ogen::findTrueBoundary(), EllipticGridGenerator::fineToCoarse(), Ogmg::fineToCoarse(), GenericMappedGridOperators::finishBoundaryConditions(), GenericMappedGridOperators::finishBoundaryConditionsOld(), HyperbolicMapping::formBlockTridiagonalSystem(), EllipticGridGenerator::getControlFunctions(), HyperbolicMapping::getNormalAndSurfaceArea(), DerivedFunctions::getUserDefinedDerivedFunction(), PlotIt::grid3d(), Ogen::interpolateMixedBoundary(), interpolateRefinements(), HyperbolicMapping::jacobiSmooth(), main(), markGhostPoints(), Ogen::markMaskAtGhost(), Ogmg::operatorAveraging(), GridSmoother::periodicUpdate(), GridStretcher::periodicUpdate(), periodicUpdate(), EllipticGridGenerator::periodicUpdate(), PlotIt::plotGrid2d(), PlotIt::plotGridBoundaries(), DataPointMapping::projectGhostPoints(), Ugen::sealHoles3D(), Oges::setEquationAndBoundaryConditions(), DataPointMapping::setTopologyMask(), GridSmoother::smooth(), Ogmg::smoothTest(), DataPointMapping::specifyTopology(), EllipticGridGenerator::stretchTheGrid(), PlotIt::surfaceGrid3d(), Integrate::surfaceIntegral(), Interpolant::testInterpolation(), Ogen::unmarkBoundaryInterpolationPoints(), Ogen::updateBoundaryAdjustment(), Ogen::updateRefinement(), Ogen::updateRefinementNew(), Ogen::updateRefinementNewer(), and SparseRepForMGF::updateToMatchGrid().

void getGhostIndex ( const IntegerArray indexArray,
int  side,
int  axis,
Index &  Ib1,
Index &  Ib2,
Index &  Ib3,
int  ghostLine = 1,
int  extra1 = 0,
int  extra2 = arrayGetIndexDefaultValue,
int  extra3 = arrayGetIndexDefaultValue 
)

References arrayGetIndexDefaultValue, axis1, axis2, axis3, End, OGcheckIndex(), R, and Start.

Referenced by Ogen::adjustForNearbyBoundaries(), MappedGridOperators::applyBCaDotGradU(), MappedGridOperators::applyBCaDotU(), MappedGridOperators::applyBCdirichlet(), MappedGridOperators::applyBCextrapolate(), MappedGridOperators::applyBCGenDiv(), MappedGridOperators::applyBCgeneralMixedDerivative(), MappedGridOperators::applyBCneumann(), MappedGridOperators::applyBCnormalComponent(), MappedGridOperators::applyBCnormalDerivative(), MappedGridOperators::applyBCnormalDotScalarGrad(), MappedGridOperators::applyBCsymmetry(), MappedGridOperators::applyBCtangentialComponent(), MappedGridOperators::applyBoundaryCondition(), MappedGridOperators::applyBoundaryConditionCoefficients(), GridSmoother::applyBoundaryConditions(), EllipticGridGenerator::applyBoundaryConditions(), HyperbolicMapping::applyBoundaryConditions(), Ogmg::applyBoundaryConditions(), Ogmg::applyFinalConditions(), Ogmg::assignBoundaryConditionCoefficients(), Ogmg::bcTest(), HyperbolicMapping::blendNormals(), Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), checkGrid(), Ogen::classifyPoints(), Ogmg::coarseGridSolverTest(), DataPointMapping::computeGhostPoints(), Integrate::computeStitchedSurfaceWeights(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), Integrate::computeWeights(), EllipticGridGenerator::defineBoundaryControlFunction(), EllipticGridGenerator::determineBoundarySpacing(), Ogmg::fineToCoarse(), SparseRepForMGF::fixUpClassify(), intMappedGridFunction::fixupUnusedPoints(), doubleMappedGridFunction::fixupUnusedPoints(), floatMappedGridFunction::fixupUnusedPoints(), getBoundaryIndex(), EllipticGridGenerator::getControlFunctions(), getGhostIndex(), HyperbolicMapping::getNormalAndSurfaceArea(), Ogmg::initializeBoundaryConditions(), HyperbolicMapping::initializeSurfaceGrid(), Ogen::interpolateMixedBoundary(), HyperbolicMapping::jacobiSmooth(), main(), markGhostPoints(), Ogen::markMaskAtGhost(), Ogmg::operatorAveraging(), Ogen::removeExteriorPoints(), Ogen::removeExteriorPointsNew(), GridSmoother::smooth(), Ogmg::smoothTest(), EllipticGridGenerator::stretchTheGrid(), Integrate::surfaceIntegral(), Ogen::sweepOutHolePoints(), SparseRepForMGF::updateToMatchGrid(), and MappedGridOperators::updateToMatchGrid().

void getIndex ( const IntegerArray indexArray,
Index &  I1,
Index &  I2,
Index &  I3,
int  extra1 = 0,
int  extra2 = arrayGetIndexDefaultValue,
int  extra3 = arrayGetIndexDefaultValue 
)

References arrayGetIndexDefaultValue, axis1, axis2, axis3, End, OGcheckIndex(), and Start.

Referenced by Ogmg::addAdjustmentForSingularProblem(), PlotIt::adjustGrid(), Ogmg::applyBoundaryConditions(), OGFunction::assignGridFunction(), Ogmg::bcTest(), Ogen::buildCutout(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), Ugen::buildHybridVertexMappings(), Ogmg::buildPredefinedCoefficientMatrix(), Ogmg::buildPredefinedVariableCoefficients(), MappingBuilder::buildSurfacePatch(), Regrid::buildTaggedCells(), checkError(), Ogen::checkForBoundaryAdjustments(), checkGrid(), Ogen::checkHoleCutting(), Stencil::checkOrder(), checkOverlappingGrid(), Ogen::checkUpdateRefinement(), Ogen::classifyPoints(), Ogen::classifyRedundantPoints(), Ogmg::coarseGridSolverTest(), EllipticGridGenerator::coarseToFine(), Ogmg::coarseToFine(), Ogmg::coarseToFineTest(), DerivedFunctions::computeDerivedFunctions(), ErrorEstimator::computeErrorFunction(), ErrorEstimator::computeFunction(), Integrate::computeLeftNullVector(), Ogmg::computeLeftNullVector(), computeMaximumSpeed(), Ogen::computeOverlap(), Integrate::computeStitchedSurfaceWeights(), Integrate::computeStitchedSurfaceWeightsOld(), AdvancingFront::computeTransformationAtPoint(), Integrate::computeWeights(), Ugen::computeZoneMasks(), Ogen::conformToCmpgrd(), PlotIt::contour1d(), PlotIt::contour2d(), PlotIt::contour3d(), Ogmg::createNullVector(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), Ogmg::defectNorm(), EllipticGridGenerator::defineBoundaryControlFunction(), EllipticGridGenerator::defineSurfaceControlFunction(), displayCoeff(), dudt(), SurfaceStitcher::enlargeGap(), SurfaceStitcher::enlargeGapWidth(), Ugen::enlargeHole(), equiGridSmoother(), EllipticGridGenerator::estimateUnderRelaxationCoefficients(), EquationSolver::evaluateExtraEquation(), Ogen::explicitHoleCutting(), fileOutput(), AssignInterpNeighbours::findInterpolationNeighbours(), GenericMappedGridOperators::findInterpolationNeighbours(), EllipticGridGenerator::fineToCoarse(), Ogmg::fineToCoarse(), Ogmg::fineToCoarseTest(), GenericMappedGridOperators::finishBoundaryConditionsOld(), SparseRepForMGF::fixUpClassify(), floatMappedGridFunction::fixupUnusedPoints(), doubleMappedGridFunction::fixupUnusedPoints(), intMappedGridFunction::fixupUnusedPoints(), Oges::formRhsAndSolutionVectors(), OGFunction::gd(), EllipticGridGenerator::generateGrid(), Ugen::generateHoleLists(), Ugen::generateInitialFaceList(), Ogen::generateInterpolationArrays(), Ugen::generateSpacingControlMesh(), Ugen::generateSpacingControlMeshForSurface(), GridFunctionNorms::getBounds(), PlotIt::getBounds(), EllipticGridGenerator::getControlFunctions(), getDt(), getError(), PlotIt::getGridBounds(), GridStatistics::getGridSpacing(), getIndex(), getInitialConditions(), EllipticGridGenerator::getResidual(), getSignForJacobian(), Ogmg::getSingularParameter(), getTrueSolution(), DerivedFunctions::getUserDefinedDerivedFunction(), PlotIt::grid3d(), Ogen::improveQuality(), ExposedPoints::initialize(), Ogmg::initializeConstantCoefficients(), Ogen::interpolateAll(), InterpolatePoints::interpolateAllPoints(), InterpolatePointsOnAGrid::interpolateAllPoints(), interpolateAllPoints(), interpolateExposedPoints(), interpolateFromControlFunction(), EllipticGridGenerator::jacobi(), Ogmg::l2Error(), Ogmg::l2Norm(), EllipticGridGenerator::lineSmoother(), main(), Oges::makeRightNullVector(), Ogen::markPointsNeededForInterpolation(), Ogen::markPointsNeededForInterpolationNew(), Ogen::markPointsReallyNeededForInterpolation(), Ogmg::maxNorm(), EllipticGridGenerator::multigridVcycle(), multiply(), ogen(), OGFunction::operator()(), Ogmg::operatorAveraging(), PlotIt::plot(), plot3dToOverture(), ErrorEstimator::plotErrorPoints(), PlotIt::plotGrid(), PlotIt::plotGrid2d(), PlotIt::plotGridQuality(), PlotIt::plotMappingEdges(), PlotIt::plotParallelGridDistribution(), Ogen::preInterpolateGrids(), GridStatistics::printGridStatistics(), printGridStatistics(), EllipticGridGenerator::redBlack(), Regrid::regridAligned(), Regrid::regridRotated(), Ogmg::removeAdjustmentForSingularProblem(), Ogen::removeExteriorPoints(), Ogen::removeExteriorPointsNew(), Ugen::removeHangingFaces(), EllipticGridGenerator::restrictMovement(), rungeKutta2(), FileOutput::saveData(), saveOvertureTextFile(), Oges::setEquationAndBoundaryConditions(), Ogmg::setMean(), GenericMappedGridOperators::setPeriodicCoefficients(), showFileFromDataFile(), GridSmoother::smooth(), ErrorEstimator::smooth(), Ogmg::smooth(), EllipticGridGenerator::smoothJacobi(), Ogmg::smoothJacobi(), Ogmg::smoothLine(), Ogmg::smoothRedBlack(), Ogmg::smoothTest(), EllipticGridGenerator::startingGrid(), PlotIt::streamLines3d(), EllipticGridGenerator::stretchTheGrid(), PlotIt::surfaceGrid3d(), Ogen::sweepOutHolePoints(), Interpolant::testInterpolation(), PlotIt::unAdjustGrid(), Ogen::unmarkInterpolationPoints(), Ogen::updateCanInterpolate(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), Ogen::updateRefinementNew(), Ogen::updateRefinementNewer(), EllipticGridGenerator::updateRightHandSideWithFASCorrection(), SparseRepForMGF::updateToMatchGrid(), PlotIt::userDefinedOutput(), Integrate::volume(), Integrate::volumeIntegral(), EllipticGridGenerator::weightFunction(), and DataFormats::writePlot3d().

Variable Documentation

const int arrayGetIndexDefaultValue =-999999