Overture  Version 25
Macros
aDotGradU.C File Reference
#include "MappedGridOperators.h"
#include "SparseRep.h"
#include "display.h"
#include "MappedGridOperatorsInclude.h"
#include "ParallelUtility.h"
#include "assignBoundaryConditions.h"
Include dependency graph for aDotGradU.C:

Macros

#define FOR_4D(m, i1, i2, i3, M, I1, I2, I3)
 
#define FOR_4(m, i1, i2, i3, M, I1, I2, I3)
 
#define FOR_3D(i1, i2, i3, I1, I2, I3)
 
#define FOR_3(i1, i2, i3, I1, I2, I3)
 
#define mask(i, j, k)   mask_ptr[ (i) + (j)*mask_Dim0 + (k)*mask_Dim1]
 
#define NORMAL(i0, i1, i2, i3)   normalp[i0+normalDim0*(i1+normalDim1*(i2+normalDim2*(i3)))]
 
#define OPX(i0, i1, i2, i3)   opXp[i0+opXDim0*(i1+opXDim1*(i2+opXDim2*(i3)))]
 
#define ADGUCOEFF(i0, i1, i2, i3)   adguCoeffp[i0+adguCoeffDim0*(i1+adguCoeffDim1*(i2+adguCoeffDim2*(i3)))]
 
#define M2(m1, m2)   ((m1)+1+3*((m2)+1))
 
#define M3(m1, m2, m3)   ((m1)+1+3*((m2)+1+3*((m3)+1)))
 
#define coeffSaved(side, axis, m)   (aCoeffValues[(side)+2*((axis)+3*(m))])
 
#define NORMAL(i0, i1, i2, i3)   normalp[i0+normalDim0*(i1+normalDim1*(i2+normalDim2*(i3)))]
 
#define RHS(i0, i1, i2, i3)   rhsp[i0+rhsDim0*(i1+rhsDim1*(i2+rhsDim2*(i3)))]
 
#define UX(i0, i1, i2)   uxp[i0+uxDim0*(i1+uxDim1*(i2))]
 
#define UY(i0, i1, i2)   uyp[i0+uyDim0*(i1+uyDim1*(i2))]
 
#define UZ(i0, i1, i2)   uzp[i0+uzDim0*(i1+uzDim1*(i2))]
 

Macro Definition Documentation

#define ADGUCOEFF (   i0,
  i1,
  i2,
  i3 
)    adguCoeffp[i0+adguCoeffDim0*(i1+adguCoeffDim1*(i2+adguCoeffDim2*(i3)))]
#define coeffSaved (   side,
  axis,
 
)    (aCoeffValues[(side)+2*((axis)+3*(m))])
#define FOR_3 (   i1,
  i2,
  i3,
  I1,
  I2,
  I3 
)
Value:
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 
)
Value:
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++)

Referenced by MappedGridOperators::applyBCaDotGradU().

#define FOR_4 (   m,
  i1,
  i2,
  i3,
  M,
  I1,
  I2,
  I3 
)
Value:
mBase=M.getBase(), mBound=M.getBound(); \
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++) \
for(m=mBase; m<=mBound; m++)
#define FOR_4D (   m,
  i1,
  i2,
  i3,
  M,
  I1,
  I2,
  I3 
)
Value:
int mBase=M.getBase(), mBound=M.getBound(); \
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++) \
for(m=mBase; m<=mBound; m++)
#define M2 (   m1,
  m2 
)    ((m1)+1+3*((m2)+1))
#define M3 (   m1,
  m2,
  m3 
)    ((m1)+1+3*((m2)+1+3*((m3)+1)))
#define mask (   i,
  j,
 
)    mask_ptr[ (i) + (j)*mask_Dim0 + (k)*mask_Dim1]

Referenced by addInteriorNodes(), Ogen::adjustBoundary(), Ogen::adjustForNearbyBoundaries(), MappedGridOperators::applyBoundaryCondition(), MappedGridOperators::applyBoundaryConditionCoefficients(), Ogmg::applyBoundaryConditions(), Ogmg::applyOgesSmoother(), Ogmg::assignBoundaryConditionCoefficients(), MappedGridOperators::assignCoefficientsInternal(), Ogmg::averageCoefficients(), Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), UnstructuredMapping::buildConnectivityLists(), Ogen::buildCutout(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), UnstructuredMapping::buildFromACompositeGrid(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), MappedGridOperators::buildNeumannCoefficientMatrix(), Ogmg::buildPredefinedCoefficientMatrix(), SurfaceStitcher::buildSurfaceCompositeGrid(), Ogen::canDiscretize(), CanInterpolate::canInterpolate(), CanInterpolate::canInterpolateOld(), Ogen::checkForOrphanPointsOnBoundaries(), checkGrid(), Ogen::checkInterpolationOnBoundaries(), checkOverlappingGrid(), checkParallelConsistency(), Ogen::checkUpdateRefinement(), Ogen::classifyPoints(), Ogmg::coarseToFine(), collectInterpolationData(), DerivedFunctions::computeDerivedFunctions(), ErrorEstimator::computeErrorFunction(), Integrate::computeLeftNullVector(), Ogmg::computeLeftNullVector(), computeMaximumSpeed(), Ogen::computeOverlap(), Integrate::computeStitchedSurfaceWeights(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), Integrate::computeWeights(), Ogen::conformToCmpgrd(), PlotIt::contour1d(), PlotIt::contour3d(), PlotIt::contourOpt2d(), Ogen::countCrossingsWithRealBoundary(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), MappedGridOperators::derivativeInternal(), Oges::determineErrors(), Ogen::determineMinimalIndexRange(), SurfaceStitcher::enlargeGap(), SurfaceStitcher::enlargeGapWidth(), fileOutput(), AssignInterpNeighbours::findInterpolationNeighbours(), GenericMappedGridOperators::findInterpolationNeighbours(), Ogen::findTrueBoundary(), Ogmg::fineToCoarse(), GenericMappedGridOperators::finishBoundaryConditions(), GenericMappedGridOperators::finishBoundaryConditionsOld(), GenericMappedGridOperators::fixBoundaryCorners(), SparseRepForMGF::fixUpClassify(), doubleMappedGridFunction::fixupUnusedPoints(), floatMappedGridFunction::fixupUnusedPoints(), intMappedGridFunction::fixupUnusedPoints(), Ogen::generateInterpolationArrays(), GridFunctionNorms::getBounds(), PlotIt::getBounds(), Ogmg::getDefect(), getDt(), getError(), PlotIt::getGridBounds(), GenericCompositeGridOperators::getInterpolationCoefficients(), ParallelGridUtility::getLocalInterpolationData(), DerivedFunctions::getUserDefinedDerivedFunction(), PlotIt::grid3d(), Ogen::improveQuality(), ExposedPoints::initialize(), Ogmg::initializeConstantCoefficients(), InterpolatePointsOnAGrid::internalInterpolate(), Ogen::interpolateAll(), InterpolatePoints::interpolateAllPoints(), InterpolatePointsOnAGrid::interpolateAllPoints(), InterpolateRefinements::interpolateCoarseFromFine(), Ogen::interpolateMixedBoundary(), interpolatePoints(), InterpolateRefinements::interpolateRefinementBoundaries(), InterpolateRefinements::interpolateRefinements(), Ogen::isNeededForDiscretization(), Ogen::isNeededForMultigridRestriction(), Ogen::isOnInterpolationBoundary(), Ogmg::l2Error(), Ogmg::l2Norm(), Ogen::lastChanceInterpolation(), main(), markGhostPoints(), Ogen::markMaskAtGhost(), Ogen::markPointsReallyNeededForInterpolation(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), CompositeSurface::oldProject(), InterpolatePointsOnAGrid::parallelInternalInterpolate(), InterpolatePointsOnAGrid::parallelSetup(), Ogen::plot(), plot3dToOverture(), ErrorEstimator::plotErrorPoints(), PlotIt::plotGrid(), PlotIt::plotGrid2d(), PlotIt::plotGridBoundaries(), Ogen::preInterpolateGrids(), Ugen::preprocessCompositeGridMasks(), printInfo(), CompositeSurface::project(), DataPointMapping::projectGhostPoints(), MappedGridData::put(), Ogen::queryAPoint(), DataFormats::readPlot3d(), IntersectionMapping::reduce(), Ogen::removeExteriorPoints(), Ogen::removeExteriorPointsNew(), Ogen::resetGrid(), saveOvertureTextFile(), GenericMappedGridOperators::setExtrapolationCoefficients(), CompositeGrid::setHybridConnectivity(), SurfaceStitcher::setMask(), GridCollection::setMaskAtRefinements(), Ogmg::setMean(), GenericMappedGridOperators::setPeriodicCoefficients(), GenericMappedGridOperators::setSymmetryCoefficients(), DataPointMapping::setTopologyMask(), showFileFromDataFile(), ErrorEstimator::smooth(), Ogmg::smoothBoundary(), Ogmg::smoothInterpolationNeighbours(), Ogmg::smoothJacobi(), Ogmg::smoothLine(), Ogmg::smoothRedBlack(), DataPointMapping::specifyTopology(), Regrid::splitBoxRotated(), PlotIt::streamLines3d(), PlotIt::surfaceGrid3d(), Ogen::sweepOutHolePoints(), Interpolant::testInterpolation(), CanInterpolate::transferInterpDataForAMR(), TrimmedMapping::triangulate(), Ogen::updateCanInterpolate(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementNew(), Ogen::updateRefinementNewer(), PlotIt::userDefinedOutput(), DataFormats::writePlot3d(), xInterpolate(), and xInterpolateOpt().

#define NORMAL (   i0,
  i1,
  i2,
  i3 
)    normalp[i0+normalDim0*(i1+normalDim1*(i2+normalDim2*(i3)))]
#define NORMAL (   i0,
  i1,
  i2,
  i3 
)    normalp[i0+normalDim0*(i1+normalDim1*(i2+normalDim2*(i3)))]
#define OPX (   i0,
  i1,
  i2,
  i3 
)    opXp[i0+opXDim0*(i1+opXDim1*(i2+opXDim2*(i3)))]
#define RHS (   i0,
  i1,
  i2,
  i3 
)    rhsp[i0+rhsDim0*(i1+rhsDim1*(i2+rhsDim2*(i3)))]
#define UX (   i0,
  i1,
  i2 
)    uxp[i0+uxDim0*(i1+uxDim1*(i2))]
#define UY (   i0,
  i1,
  i2 
)    uyp[i0+uyDim0*(i1+uyDim1*(i2))]
#define UZ (   i0,
  i1,
  i2 
)    uzp[i0+uzDim0*(i1+uzDim1*(i2))]