Overture
Version 25
|
Go to the source code of this file.
Macros | |
#define | MATHUTIL_H "Mathutil.h" |
#define | SQR(x) ((x)*(x)) |
#define | SQRT(x) sqrt((x)) |
#define | ARRAY_GET_DATA_POINTER(type, aType) |
Functions | |
int | max (int x1, int x2) |
int | max (int x1, unsigned int x2) |
int | max (unsigned int x1, int x2) |
int | max (unsigned long x1, int x2) |
int | max (int x1, unsigned long x2) |
double | max (int x1, double x2) |
double | max (double x1, int x2) |
float | max (int x1, float x2) |
float | max (float x1, int x2) |
float | max (float x1, float x2) |
double | max (double x1, double x2) |
double | max (float x1, double x2) |
double | max (double x1, float x2) |
int | min (int x1, int x2) |
float | min (float x1, float x2) |
double | min (double x1, double x2) |
double | min (float x1, double x2) |
double | min (double x1, float x2) |
int | max (int x1, int x2, int x3) |
int | max (int x1, int x2, int x3, int x4) |
int | max (int x1, int x2, int x3, int x4, int x5) |
float | max (float x1, float x2, float x3) |
float | max (float x1, float x2, float x3, float x4) |
float | max (float x1, float x2, float x3, float x4, float x5) |
double | max (double x1, double x2, double x3) |
double | max (double x1, double x2, double x3, double x4) |
double | max (double x1, double x2, double x3, double x4, double x5) |
int | min (int x1, int x2, int x3) |
int | min (int x1, int x2, int x3, int x4) |
int | min (int x1, int x2, int x3, int x4, int x5) |
float | min (float x1, float x2, float x3) |
float | min (float x1, float x2, float x3, float x4) |
float | min (float x1, float x2, float x3, float x4, float x5) |
double | min (double x1, double x2, double x3) |
double | min (double x1, double x2, double x3, double x4) |
double | min (double x1, double x2, double x3, double x4, double x5) |
int | rounder (double x) |
double | pow (int x1, int x2) |
float | atan2 (float x1, float x2) |
float | atan2 (double x1, float x2) |
float | atan2 (float x1, double x2) |
float | fmod (float x1, float x2) |
float | fmod (double x1, float x2) |
float | fmod (float x1, double x2) |
int | sign (int x) |
int | sign (float x) |
int | sign (double x) |
double | log10 (int x) |
double | log (int x) |
double | fabs (int x) |
int | floorDiv (int numer, int denom) |
#define ARRAY_GET_DATA_POINTER | ( | type, | |
aType | |||
) |
#define MATHUTIL_H "Mathutil.h" |
Referenced by EdgeInfo::adjustOneSegmentEndPoints(), EllipticGridGenerator::applyBoundaryConditions(), HyperbolicMapping::applyBoundaryConditions(), Ogmg::assignBoundaryConditionCoefficients(), MappedGridOperators::assignCoefficientsInternal(), OrthographicTransform::basicInverse(), CylinderMapping::basicInverse(), LineMapping::basicInverse(), SphereMapping::basicInverse(), CrossSectionMapping::basicInverse(), OrthographicTransform::basicInverseS(), UserDefinedMapping1::basicInverseS(), CylinderMapping::basicInverseS(), LineMapping::basicInverseS(), SphereMapping::basicInverseS(), ApproximateGlobalInverse::binarySearchOverBoundary(), HyperbolicMapping::blendNormals(), Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), Ogmg::buildExtraLevelsNew(), UnstructuredMapping::buildFromACompositeSurface(), UnstructuredMapping::buildFromARegularMapping(), OffsetShell::buildOffsetMappings(), CompositeTopology::buildSubSurfaceTriangulation(), MappingBuilder::buildSurfacePatch(), UnstructuredMapping::buildUnstructuredGrid(), Mapping::checkMapping(), Stencil::checkOrder(), closerSurfaceFound(), UnstructuredMapping::computeConnection(), DerivedFunctions::computeDerivedFunctions(), ErrorEstimator::computeErrorFunction(), ErrorEstimator::computeFunction(), computeMaximumSpeed(), Triangle::computeNormal(), GridSmoother::computeNormals(), Ogen::computeOverlap(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), Integrate::computeWeights(), PlotIt::contourCuts(), SmoothedPolygon::correctPolygonForCorners(), HyperbolicMapping::correctProjectionOfInitialCurve(), MappingsFromCAD::createCompositeCurve(), HyperbolicMapping::createCurveOnSurface(), crossProductAndAngle(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), EllipticGridGenerator::defineBoundaryControlFunction(), EllipticGridGenerator::defineSurfaceControlFunction(), MappedGridOperators::derivativeInternal(), MappedGridOperators::derivativeScalarDerivativeCoefficients(), derivativeScalarDerivativeFDerivative21(), derivativeScalarDerivativeFDerivative21R(), derivativeScalarDerivativeFDerivative22(), derivativeScalarDerivativeFDerivative22R(), derivativeScalarDerivativeFDerivative23(), derivativeScalarDerivativeFDerivative23R(), derivativeScalarDerivativeFDerivCoefficients2(), Ogen::determineBoundaryPointsToAdjust(), EllipticGridGenerator::determineBoundarySpacing(), Mapping::determineResolution(), distancel2(), ApproximateGlobalInverse::distanceToCell(), divScalarGradFDerivative21(), divScalarGradFDerivative21R(), divScalarGradFDerivative22(), divScalarGradFDerivative22R(), divScalarGradFDerivative23(), divScalarGradFDerivative23R(), divScalarGradFDerivCoefficients2(), divScalarGradFDerivCoefficients2R(), PlotIt::drawAStreamLine(), TrimmedMapping::editNurbsTrimCurve(), equiGridSmoother(), TrimmedMapping::findClosestCurve(), UnstructuredMapping::findClosestEntity(), TrimmedMapping::findDistanceToACurve(), HyperbolicMapping::findMatchingBoundaryCurve(), Mapping::findNearestGridPoint(), InterpolatePointsOnAGrid::findNearestValidGridPoint(), findNearestValidGridPoint(), HyperbolicMapping::findNormalsToStartCurve(), CompositeSurface::findOutwardTangent(), RotatedBox::fitBox(), OGPulseFunction::gd(), HyperbolicMapping::generate(), Oges::generateMatrix(), Mapping::getArcLength(), EllipticGridGenerator::getControlFunctions(), GridStatistics::getGridSpacing(), Ogmg::getInterpolationCoordinatesNew(), Ogmg::getInterpolationStencil(), getNormal(), UnstructuredMapping::getNormal(), Ogen::getNormal(), HyperbolicMapping::getNormalAndSurfaceArea(), CompositeSurface::getNormals(), Triangle::getRelativeCoordinates(), EllipticGridGenerator::getResidual(), getTimeStep(), getTrueSolution(), DerivedFunctions::getUserDefinedDerivedFunction(), improveTriangulation(), FilletMapping::initialize(), StretchMapping::initialize(), CrossSectionMapping::initialize(), SplineMapping::initialize(), ReparameterizationTransform::initializeEquidistribution(), NurbsMapping::interpolate(), Ogen::interpolateAPoint(), Ogen::interpolateMixedBoundary(), NurbsMapping::interpolateSurface(), NurbsMapping::interpolateVolume(), IntersectionMapping::intersectCurves(), RotatedBox::intersects(), IntersectionMapping::intersectWithCompositeSurface(), ExactLocalInverse::inverse(), StretchMapping::inverseMapS(), UnstructuredMapping::isDuplicateNode(), laplaceFDerivative(), laplaceFDerivative22(), laplaceFDerivative23(), laplaceFDerivative42(), laplaceFDerivative43(), laplaceFDerivCoefficients(), laplaceFDerivCoefficients2(), laplaceFDerivCoefficients42(), laplaceFDerivCoefficients43(), OGTrigFunction::laplacian(), EllipticGridGenerator::lineSmoother(), main(), Stencil::makeCoefficients(), NormalMapping::map(), OrthographicTransform::map(), AirfoilMapping::map(), FilletMapping::map(), CrossSectionMapping::mapBuiltin(), CrossSectionMapping::mapGeneralWithPolarSingularity(), NormalMapping::mapS(), AirfoilMapping::mapS(), OrthographicTransform::mapS(), UserDefinedMapping1::mapS(), StretchMapping::mapS(), HyperbolicMapping::matchToCurve(), NurbsMapping::merge(), HyperbolicMapping::normalize(), CompositeSurface::oldProject(), OGPulseFunction::operator()(), SphereMapping::outside(), plot3dToOverture(), HyperbolicMapping::plotDirectionArrows(), PlotIt::plotGridQuality(), printGridStatistics(), GL_GraphicsInterface::processSpecialMenuItems(), CompositeSurface::project(), UnstructuredMapping::project(), Mapping::project(), HyperbolicMapping::project(), DataPointMapping::projectGhostPoints(), rDerivative(), NurbsMapping::readFromIgesFile(), CompositeSurface::refineSubSurface(), Ogen::removeExteriorPoints(), IntersectionMapping::reparameterize(), rot3d(), rrDerivative(), rsDerivative(), rtDerivative(), scalarGradFDerivative(), sDerivative(), Mapping::secondOrderDerivative(), RevolutionMapping::setLineOfRevolution(), SmoothedPolygon::setPolygon(), OGPulseFunction::setRadius(), spewPrimitiveEPS(), ssDerivative(), stDerivative(), PlotIt::streamLines3d(), OGPulseFunction::t(), tDerivative(), Stencil::test(), TrimmedMapping::triangulate(), ttDerivative(), OGPulseFunction::u(), SmoothedPolygon::update(), SplineMapping::update(), CompositeSurface::update(), HyperbolicMapping::update(), Mapping::update(), SparseRepForMGF::updateToMatchGrid(), OGPulseFunction::ut(), OGPulseFunction::ux(), OGPulseFunction::uxx(), OGPulseFunction::uxy(), OGPulseFunction::uxz(), OGPulseFunction::uy(), OGPulseFunction::uyy(), OGPulseFunction::uyz(), OGPulseFunction::uz(), OGPulseFunction::uzz(), UnstructuredMapping::validStitch(), EllipticGridGenerator::weightFunction(), OGPulseFunction::x(), xFDerivative(), xFDerivative22(), xFDerivative23(), xFDerivative42(), xFDerivative43(), MappedGridOperators::xiCoefficients(), OGTrigFunction::xx(), OGPulseFunction::xx(), xxFDerivative(), xxFDerivative22(), xxFDerivative23(), xxFDerivative42(), xxFDerivative43(), xxFDerivCoefficients(), OGPulseFunction::xxx(), OGPulseFunction::xxxx(), OGPulseFunction::xy(), xyFDerivative(), xyFDerivative22(), xyFDerivative23(), xyFDerivative42(), xyFDerivative43(), xyFDerivCoefficients(), xyFDerivCoefficients4(), OGPulseFunction::xz(), xzFDerivative(), xzFDerivative22(), xzFDerivative23(), xzFDerivative42(), xzFDerivative43(), xzFDerivCoefficients(), xzFDerivCoefficients4(), OGPulseFunction::y(), yFDerivative(), yFDerivative22(), yFDerivative23(), yFDerivative42(), yFDerivative43(), OGTrigFunction::yy(), OGPulseFunction::yy(), yyFDerivative(), yyFDerivative22(), yyFDerivative23(), yyFDerivative42(), yyFDerivative43(), yyFDerivCoefficients(), OGPulseFunction::yz(), yzFDerivative(), yzFDerivative22(), yzFDerivative23(), yzFDerivative42(), yzFDerivative43(), yzFDerivCoefficients(), yzFDerivCoefficients4(), OGPulseFunction::z(), zFDerivative(), zFDerivative22(), zFDerivative23(), zFDerivative42(), zFDerivative43(), OGTrigFunction::zz(), OGPulseFunction::zz(), zzFDerivative(), zzFDerivative22(), zzFDerivative23(), zzFDerivative42(), zzFDerivative43(), and zzFDerivCoefficients().
Referenced by CompositeGrid::add(), MappedGridOperators::applyBCaDotU(), MappedGridOperators::applyBoundaryConditionCoefficients(), HyperbolicMapping::applyBoundaryConditions(), Triangle::area(), RevolutionMapping::basicInverse(), OrthographicTransform::basicInverse(), CrossSectionMapping::basicInverse(), RevolutionMapping::basicInverseS(), OrthographicTransform::basicInverseS(), DataPointMapping::basicInverseS(), HyperbolicMapping::blendNormals(), Ogen::buildACompositeGrid(), Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), UnstructuredMapping::buildFromACompositeSurface(), UnstructuredMapping::buildFromARegularMapping(), OffsetShell::buildOffsetMappings(), NurbsMapping::buildSubCurves(), UnstructuredMapping::buildUnstructuredGrid(), Mapping::checkMapping(), Ogen::computeInterpolationQuality(), Triangle::computeNormal(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), Integrate::computeWeights(), GL_GraphicsInterface::constructor(), MappingsFromCAD::createCompositeCurve(), HyperbolicMapping::createCurveOnSurface(), crossProductAndAngle(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), EllipticGridGenerator::defineBoundaryControlFunction(), EllipticGridGenerator::defineSurfaceControlFunction(), Ogen::determineBoundaryPointsToAdjust(), EllipticGridGenerator::determineBoundarySpacing(), Mapping::determineResolution(), equiGridSmoother(), UnstructuredMapping::findBoundaryCurves(), HyperbolicMapping::findMatchingBoundaryCurve(), HyperbolicMapping::findNormalsToStartCurve(), CompositeSurface::findOutwardTangent(), RotatedBox::fitBox(), HyperbolicMapping::generate(), EllipticGridGenerator::getControlFunctions(), UnstructuredMapping::getNormal(), HyperbolicMapping::getNormalAndSurfaceArea(), CompositeSurface::getNormals(), DerivedFunctions::getUserDefinedDerivedFunction(), FilletMapping::initialize(), CrossSectionMapping::initialize(), SplineMapping::initialize(), ReparameterizationTransform::initializeEquidistribution(), ApproximateGlobalInverse::insideGrid(), NurbsMapping::interpolate(), NurbsMapping::interpolateSurface(), NurbsMapping::interpolateVolume(), IntersectionMapping::intersectCurves(), RotatedBox::intersects(), ExactLocalInverse::inverse(), main(), SmoothedPolygon::map(), RevolutionMapping::map(), OrthographicTransform::map(), AirfoilMapping::map(), QuadraticMapping::map(), CrossSectionMapping::mapBuiltin(), CrossSectionMapping::mapGeneralWithPolarSingularity(), SmoothedPolygon::mapS(), RevolutionMapping::mapS(), AirfoilMapping::mapS(), OrthographicTransform::mapS(), StretchMapping::mapS(), HyperbolicMapping::matchToCurve(), NurbsMapping::merge(), IntersectionMapping::newtonIntersection(), HyperbolicMapping::normalize(), HyperbolicMapping::plotDirectionArrows(), PlotIt::plotGridQuality(), GL_GraphicsInterface::processSpecialMenuItems(), CompositeSurface::project(), UnstructuredMapping::project(), Mapping::project(), HyperbolicMapping::project(), NurbsMapping::readFromIgesFile(), MappingsFromCAD::readOneCurve(), Regrid::regridRotated(), IntersectionMapping::reparameterize(), RevolutionMapping::setLineOfRevolution(), CompositeGrid::setOverlapParameters(), SmoothedPolygon::setPolygon(), spewPrimitiveEPS(), PlotIt::streamLines3d(), TrimmedMapping::triangulate(), SmoothedPolygon::update(), SplineMapping::update(), Mapping::update(), UnstructuredMapping::validStitch(), and EllipticGridGenerator::weightFunction().
|
inline |
Referenced by atan2(), RevolutionMapping::basicInverse(), AnnulusMapping::basicInverse(), CircleMapping::basicInverse(), CylinderMapping::basicInverse(), SphereMapping::basicInverse(), CrossSectionMapping::basicInverse(), RevolutionMapping::basicInverseS(), AnnulusMapping::basicInverseS(), UserDefinedMapping1::basicInverseS(), CylinderMapping::basicInverseS(), SphereMapping::basicInverseS(), UserDefinedMapping1::bladeSetup(), RocketMapping::computeStarPoints(), NurbsMapping::conic(), PlotIt::drawAStreamLine(), main(), OrthographicTransform::map(), OrthographicTransform::mapS(), NurbsMapping::readFromIgesFile(), MappingsFromCAD::readOneCurve(), and Regrid::regridRotated().
|
inline |
References atan2().
|
inline |
References atan2().
|
inline |
Referenced by addInteriorNodes(), Ogen::adjustForNearbyBoundaries(), AdvancingFront::advanceFront(), MappedGridOperators::applyBCGenDiv(), MappedGridOperators::applyBoundaryConditionCoefficients(), GridSmoother::applyBoundaryConditions(), EllipticGridGenerator::applyBoundaryConditions(), Ogmg::applyBoundaryConditions(), TrimmedMapping::assembleSubCurves(), MappingBuilder::assignBoundaryConditions(), RevolutionMapping::basicInverse(), CircleMapping::basicInverse(), CrossSectionMapping::basicInverse(), RevolutionMapping::basicInverseS(), DataPointMapping::basicInverseS(), UserDefinedMapping1::bladeSetup(), BoxMapping::BoxMapping(), Integrate::buildAdaptiveMeshRefinementSurfaceWeights(), MappingBuilder::buildBoxGrid(), NurbsMapping::buildCurveOnSurface(), CompositeTopology::buildEdgeSegment(), Ogmg::buildExtraLevelsNew(), UnstructuredMapping::buildFromACompositeSurface(), UnstructuredMapping::buildFromARegularMapping(), InterpolatePoints::buildInterpolationInfo(), InterpolatePointsOnAGrid::buildInterpolationInfo(), buildParameterCurveFromSpaceCurve(), Ogmg::buildPredefinedCoefficientMatrix(), UnstructuredMapping::buildSearchTree(), CompositeTopology::buildSubSurfaceTriangulation(), CanInterpolate::canInterpolate(), CompositeGridData::canInterpolate(), CanInterpolate::canInterpolateOld(), CanInterpolate::cgCanInterpolate(), Ogen::checkBoundaryAdjustment(), checkError(), Ogmg::checkForBetterQualityInterpolation(), Ogen::checkInterpolationOnBoundaries(), Mapping::checkMapping(), checkOverlappingGrid(), Ogen::checkRefinementInterpolation(), Ogen::checkRefinementInterpolationNew(), NurbsMapping::circle(), Ogmg::coarseGridSolverTest(), Ogmg::coarseToFineTest(), UnstructuredMapping::computeConnection(), DerivedFunctions::computeDerivedFunctions(), ParallelOverlappingGridInterpolator::computeError(), ErrorEstimator::computeErrorFunction(), Ogen::computeInterpolationQuality(), CompositeTopology::computeNumberOfGridPoints(), computeRate(), computeRateOld(), RocketMapping::computeSlotPoints(), RocketMapping::computeStarPoints(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), MappingGeometry::computeVolumeIntegrals(), Integrate::computeWeights(), PlotIt::contour2d(), PlotIt::contour3d(), HyperbolicMapping::correctProjectionOfInitialCurve(), ApproximateGlobalInverse::countCrossingsWithPolygon(), Ogen::countCrossingsWithRealBoundary(), MappingsFromCAD::createCompositeCurve(), MappingsFromCAD::createCurveOnAParametricSurface(), HyperbolicMapping::createCurveOnSurface(), createSurfaceForAFace(), CrossSectionMapping::CrossSectionMapping(), TrimmedMapping::curveGoesThrough(), curveTooNarrow(), Ogen::cutHoles(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), EllipticGridGenerator::defineSurfaceControlFunction(), GridDistribution::determineAGoodNumberOfProcessors(), Ogen::determineBoundaryPointsToAdjust(), Oges::determineErrors(), IntersectionMapping::determineIntersection(), LoadBalancer::determineLoadBalanceKernighanLin(), TMquad::distancePointToSegment(), PlotIt::drawAStreamLine(), GL_GraphicsInterface::drawColourBar(), HyperbolicMapping::drawHyperbolicGrid(), TrimmedMapping::editNurbsTrimCurve(), equidistribute(), equiGridSmoother(), EllipticGridGenerator::estimateUnderRelaxationCoefficients(), Ogen::explicitHoleCutting(), fabs(), Ogen::findBestGuess(), CompositeTopology::findBoundaryCurves(), Ogen::findClosestBoundaryPoint(), HyperbolicMapping::findMatchingBoundaryCurve(), CompositeSurface::findNearbySurfaces(), ApproximateGlobalInverse::findNearestGridPoint(), CompositeSurface::findOutwardTangent(), findRBound(), SweepMapping::findRowSplines(), Ogmg::fineToCoarse(), Ogmg::fineToCoarseTest(), NurbsMapping::forcedMerge(), HyperbolicMapping::generate(), EllipticGridGenerator::generateGrid(), Oges::generateMatrix(), get_circle_center(), get_circle_center_on_plane(), Mapping::getArcLength(), EllipticGridGenerator::getControlFunctions(), HyperbolicMapping::getDistanceToStep(), getDt(), CompositeTopology::getEdgeFromEndPoints(), RotatedBox::getEfficiency(), Ogen::getHoleWidth(), getInitialConditions(), GenericCompositeGridOperators::getInterpolationCoefficients(), Ogmg::getInterpolationCoordinates(), Ogmg::getInterpolationCoordinatesNew(), Ogmg::getInterpolationCoordinatesNewOld(), ExposedPoints::getInterpolationStencil(), Mapping::getMappingParametersOption(), CompositeTopology::getNearestEdge(), Triangle::getRelativeCoordinates(), getTimeStep(), DerivedFunctions::getUserDefinedDerivedFunction(), idealVertexIteration(), CircleMapping::initialize(), JoinMapping::initialize(), FilletMapping::initialize(), SplineMapping::initialize(), NurbsMapping::initialize(), ApproximateGlobalInverse::initializeBoundingBoxTrees(), Ogmg::initializeConstantCoefficients(), ReparameterizationTransform::initializeEquidistribution(), HyperbolicMapping::initializeMarchingParameters(), HyperbolicMapping::initializeSurfaceGrid(), TrimmedMapping::initializeTrimCurves(), UnstructuredMapping::insideOrOutside(), ParallelOverlappingGridInterpolator::internalInterpolate(), ExposedPoints::interpolate(), Ogen::interpolateAPoint(), Interpolate::interpolateCoarseToFine(), interpolateExposedPoints(), Ogen::interpolateMixedBoundary(), interpolatePoints(), intersect2D(), intersect3D(), NurbsMapping::intersect3DLines(), IntersectionMapping::intersectCurves(), Triangle::intersects(), IntersectionMapping::intersectWithCompositeSurface(), TMquad::inThisSquare(), ExactLocalInverse::inverse(), StretchMapping::inverseMapS(), Mapping::inverseMapS(), isBetweenOpenInterval2D(), UnstructuredMapping::isDuplicateNode(), AdvancingFront::isFaceConsistent2D(), AdvancingFront::isFaceConsistent3D(), EllipticGridGenerator::jacobi(), Ogen::lastChanceInterpolation(), main(), AdvancingFront::makeTriOnSurface(), SmoothedPolygon::map(), NormalMapping::map(), RevolutionMapping::map(), OrthographicTransform::map(), DepthMapping::map(), CrossSectionMapping::mapBuiltin(), CrossSectionMapping::mapGeneralWithPolarSingularity(), SmoothedPolygon::mapS(), NormalMapping::mapS(), RevolutionMapping::mapS(), OrthographicTransform::mapS(), StretchMapping::mapS(), Ogmg::maxNorm(), CompositeTopology::merge(), NurbsMapping::merge(), CompositeTopology::mergeEdgeCurves(), NurbsMapping::moveEndpoint(), EllipticGridGenerator::multigridVcycle(), IntersectionMapping::newtonIntersection(), CompositeSurface::oldProject(), optimize_one_node_newton_fv(), optimize_one_node_steepest_descent(), EllipticGridGenerator::periodicUpdate(), Ogen::plot(), GL_GraphicsInterface::plotAxes(), PlotIt::plotGrid(), PlotIt::plotGridQuality(), GL_GraphicsInterface::plotLines(), GL_GraphicsInterface::plotPoints(), PlotIt::plotStructured(), PlotIt::plotTrimmedMapping(), Ogen::printOrphanPoints(), LoftedSurfaceMapping::profileSetup(), IntersectionMapping::project(), CompositeSurface::project(), UnstructuredMapping::project(), HyperbolicMapping::project(), EllipticGridGenerator::projectBoundaryPoints(), DataPointMapping::projectGhostPoints(), HyperbolicMapping::projectNormalsToMatchCurve(), UnstructuredMapping::projectOnTriangle(), Ogen::projectToBoundary(), Ogen::projectToParameterBoundary(), Ogen::queryAPoint(), NurbsMapping::readFromIgesFile(), MappingsFromCAD::readOneCurve(), DataFormats::readPlot3d(), IntersectionMapping::reduce(), refineTriangulation(), AdvancingFront::removeFaceFromFront(), IntersectionMapping::reOrder(), NurbsMapping::reparameterize(), residual(), LoadBalancer::saveStatistics(), GL_GraphicsInterface::selectNew(), CylinderMapping::setAngle(), AnnulusMapping::setAngleBounds(), OGPolyFunction::setCoefficients(), SplineMapping::setDomainInterval(), NurbsMapping::setDomainInterval(), RevolutionMapping::setRevolutionAngle(), Mapping::setSignForJacobian(), DataPointMapping::setTopologyMask(), GridSmoother::smooth(), Ogmg::smooth(), Ogmg::smoothLine(), TrimmedMapping::snapCurvesToIntersection(), YaleEquationSolver::solve(), HarwellEquationSolver::solve(), SlapEquationSolver::solve(), spewPrimitiveEPS(), SphereMapping::SphereMapping(), CompositeTopology::splitAndMergeEdgeCurves(), CompositeTopology::splitEdge(), PlotIt::streamLines2d(), PlotIt::streamLines3d(), swapFace(), NurbsMapping::transformKnots(), TrimmedMapping::triangulate(), CompositeTopology::triangulateCompositeSurface(), NurbsMapping::truncateToDomainBounds(), StretchTransform::update(), CircleMapping::update(), AnnulusMapping::update(), SphereMapping::update(), CrossSectionMapping::update(), StretchMapping::update(), SplineMapping::update(), CompositeSurface::update(), TrimmedMapping::update(), HyperbolicMapping::update(), Mapping::update(), NurbsMapping::update(), Ogen::updateBoundaryAdjustment(), HyperbolicMapping::updateSurfaceGridParameters(), PlotIt::userDefinedOutput(), verifyUnstructuredConnectivity(), EllipticGridGenerator::weightFunction(), xInterpolate(), xInterpolateOpt(), and UNSTRUCTURED_OPS_FV2::xixj_uFV2().
|
inline |
|
inline |
Referenced by RevolutionMapping::basicInverse(), AnnulusMapping::basicInverse(), CircleMapping::basicInverse(), RestrictionMapping::basicInverse(), CylinderMapping::basicInverse(), SphereMapping::basicInverse(), CrossSectionMapping::basicInverse(), RevolutionMapping::basicInverseS(), AnnulusMapping::basicInverseS(), UserDefinedMapping1::basicInverseS(), RestrictionMapping::basicInverseS(), CylinderMapping::basicInverseS(), SphereMapping::basicInverseS(), DataPointMapping::basicInverseS(), Mapping::checkMapping(), Ogen::cutHolesNewer(), fmod(), ExposedPoints::getInterpolationStencil(), SmoothedPolygon::map(), OrthographicTransform::map(), AirfoilMapping::map(), SmoothedPolygon::mapS(), AirfoilMapping::mapS(), OrthographicTransform::mapS(), DataPointMapping::mapS(), SplineMapping::mapS(), NurbsMapping::mapS(), DataPointMapping::mapScalar(), NurbsMapping::mapVector(), Mapping::periodicShift(), GL_GraphicsInterface::plotAxes(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), and Ogen::updateRefinementNew().
|
inline |
References fmod().
|
inline |
References fmod().
|
inline |
Referenced by Stencil::checkOrder(), DerivedFunctions::computeDerivedFunctions(), computeRate(), computeRateOld(), Interpolate::interpolateCoarseToFine(), ExactLocalInverse::inverse(), StretchMapping::inverseMapS(), StretchMapping::mapS(), HyperbolicMapping::updateLinesAndDistanceToMarch(), and StretchTransform::updateStretchingParameters().
|
inline |
Referenced by display(), outputLatexTable(), ShowFilePlotter::plot(), and GL_GraphicsInterface::plotAxes().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
References max().
|
inline |
References max().
|
inline |
References max().
|
inline |
References max().
|
inline |
References max().
|
inline |
References max().
|
inline |
References max().
|
inline |
References max().
|
inline |
References max().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
References min().
|
inline |
References min().
|
inline |
References min().
|
inline |
References min().
|
inline |
References min().
|
inline |
References min().
|
inline |
References min().
|
inline |
References min().
|
inline |
References min().
|
inline |
References rounder().
Referenced by HyperbolicMapping::adjustDistanceToMarch(), MappedGridOperators::applyBCaDotGradU(), MappedGridOperators::applyBCgeneralMixedDerivative(), MappedGridOperators::applyBCneumann(), MappedGridOperators::applyBCnormalDerivative(), CrossSectionMapping::basicInverse(), InterpolateRefinements::boxWasAdjustedInPeriodicDirection(), Ogmg::buildCoefficientArrays(), CompositeTopology::buildEdgeSegment(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), Regrid::buildGrids(), Ogmg::buildPredefinedCoefficientMatrix(), Ogmg::buildPredefinedEquations(), Regrid::buildProperNestingDomains(), changeNormal(), checkGrid(), Mapping::checkMapping(), EllipticGridGenerator::coarseToFine(), FilamentMapping::computeCurveFrameTimeDerivatives(), DerivedFunctions::computeDerivedFunctions(), computeDeviation(), AdvancingFront::computeFaceNormal(), AdvancingFront::computeFaceNormalTransformation(), FilamentMapping::computeGeometricData(), Integrate::computeLeftNullVector(), computeRate(), computeRateOld(), RocketMapping::computeSlotPoints(), RocketMapping::computeStarPoints(), AdvancingFront::computeSurfaceNormal(), FilamentMapping::computeTravelingWaveFilamentTimeDerivatives(), Integrate::computeWeights(), Ogmg::cycle(), TrimmedMapping::editNurbsTrimCurve(), HyperbolicMapping::estimateMarchingParameters(), evaluateDeviation(), EllipticGridGenerator::fineToCoarse(), FourierOperators::fourierDerivative(), FourierOperators::fourierLaplacian(), Ogmg::fullMultigrid(), OGTrigFunction::gd(), OGPulseFunction::gd(), EllipticGridGenerator::generateGrid(), Ugen::generateSpacingControlMesh(), get_circle_center(), HyperbolicMapping::getDistanceToStep(), getDt(), floatMappedGridFunction::getGridFunctionType(), doubleMappedGridFunction::getGridFunctionType(), intMappedGridFunction::getGridFunctionType(), ApproximateGlobalInverse::getPeriodicImages(), ApproximateGlobalInverse::initializeBoundingBoxTrees(), Ogmg::initializeConstantCoefficients(), HyperbolicMapping::initializeMarchingParameters(), EllipticGridGenerator::jacobi(), EllipticGridGenerator::lineSmoother(), lpNorm(), main(), NormalMapping::map(), AirfoilMapping::map(), NormalMapping::mapS(), AirfoilMapping::mapS(), NurbsMapping::mapS(), NurbsMapping::moveEndpoint(), EllipticGridGenerator::multigridVcycle(), numberOfPossibleMultigridLevels(), OGPulseFunction::operator()(), Ogmg::operatorAveraging(), Ogmg::outputCycleInfo(), MeshQualityMetrics::outputHistogram(), outputLatexTable(), Ogmg::outputResults(), GL_GraphicsInterface::pickNew(), GL_GraphicsInterface::pickPoints(), GL_GraphicsInterface::pickToWorldCoordinates(), GL_GraphicsInterface::plotAxes(), NurbsMapping::readFromIgesFile(), EllipticGridGenerator::redBlack(), refineCurve(), Ogen::removeExteriorPointsNew(), Mapping::secondOrderDerivative(), Oges::setEquationAndBoundaryConditions(), CompositeGrid::setHybridConnectivity(), floatMappedGridFunction::setIsACoefficientMatrix(), intMappedGridFunction::setIsACoefficientMatrix(), doubleMappedGridFunction::setIsACoefficientMatrix(), EllipticGridGenerator::setup(), GenericGridCollectionOperators::setup(), GenericCompositeGridOperators::setup(), Regrid::setupCoarseIndexSpace(), Ogmg::smooth(), TrimmedMapping::snapCurvesToIntersection(), YaleEquationSolver::solve(), SlapEquationSolver::solve(), EllipticGridGenerator::startingGrid(), Ogen::sweepOutHolePoints(), OGPulseFunction::t(), OGPulseFunction::u(), TrimmedMapping::update(), Mapping::update(), HyperbolicMapping::updateLinesAndDistanceToMarch(), Ogen::updateOverlap(), Ogen::updateRefinementFillInterpolationData(), StretchTransform::updateStretchingParameters(), SparseRepForMGF::updateToMatchGrid(), MappedGridOperators::updateToMatchGrid(), OGPulseFunction::ut(), OGPulseFunction::ux(), OGPulseFunction::uxx(), OGPulseFunction::uxy(), OGPulseFunction::uxz(), OGPulseFunction::uy(), OGPulseFunction::uyy(), OGPulseFunction::uyz(), OGPulseFunction::uz(), OGPulseFunction::uzz(), OGPulseFunction::x(), UNSTRUCTURED_OPS_FV2::xixj_uFV2(), OGPulseFunction::xx(), OGTrigFunction::xxx(), OGPulseFunction::xxx(), OGTrigFunction::xxxx(), OGPulseFunction::xxxx(), OGPulseFunction::xy(), OGPulseFunction::xz(), OGPulseFunction::y(), OGPulseFunction::yy(), OGPulseFunction::yz(), OGPulseFunction::z(), and OGPulseFunction::zz().
|
inline |
|
inline |
Referenced by Mapping::getSignForJacobian(), Triangle::intersects(), and HyperbolicMapping::plotDirectionArrows().
|
inline |
|
inline |