Overture
Version 25
|
#include "Overture.h"
#include "display.h"
#include "InterpolatePointsOnAGrid.h"
#include "ParallelUtility.h"
#include "SparseArray.h"
Macros | |
#define | Q11(x) (1.-(x)) |
#define | Q21(x) (x) |
#define | Q12(x) .5*((x)-1.)*((x)-2.) |
#define | Q22(x) (x)*(2.-(x)) |
#define | Q32(x) .5*(x)*((x)-1.) |
#define | q(axis, m) qp[axis+3*(m)] |
#define | dr(axis) drp[axis] |
#define | ir(side, axis) irp[side+2*(axis)] |
#define | isCC(axis) isCellCenteredp[axis] |
#define | IL(i0, i1) ipp[i0+ipDim0*(i1)] |
#define | CI(i0, i1) cip[i0+ciDim0*(i1)] |
#define | VIW(i) viw(i) |
#define | coeffg(i, m1, m2, m3) coeffap[i+nil*((m1)+width[0]*((m2)+width[1]*(m3)))] |
#define | q10(x) 1 |
#define | q20(x) -(x)+1 |
#define | q21(x) (x) |
#define | q30(x) ((x)-1)*((x)-2)/2. |
#define | q31(x) -(x)*((x)-2) |
#define | q32(x) (x)*((x)-1)/2. |
#define | q40(x) -((x)-1)*((x)-2)*((x)-3)/6. |
#define | q41(x) (x)*((x)-2)*((x)-3)/2. |
#define | q42(x) -(x)*((x)-1)*((x)-3)/2. |
#define | q43(x) (x)*((x)-1)*((x)-2)/6. |
#define | q50(x) ((x)-1)*((x)-2)*((x)-3)*((x)-4)/24. |
#define | q51(x) -(x)*((x)-2)*((x)-3)*((x)-4)/6. |
#define | q52(x) (x)*((x)-1)*((x)-3)*((x)-4)/4. |
#define | q53(x) -(x)*((x)-1)*((x)-2)*((x)-4)/6. |
#define | q54(x) (x)*((x)-1)*((x)-2)*((x)-3)/24. |
#define | q60(x) -((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)/120. |
#define | q61(x) (x)*((x)-2)*((x)-3)*((x)-4)*((x)-5)/24. |
#define | q62(x) -(x)*((x)-1)*((x)-3)*((x)-4)*((x)-5)/12. |
#define | q63(x) (x)*((x)-1)*((x)-2)*((x)-4)*((x)-5)/12. |
#define | q64(x) -(x)*((x)-1)*((x)-2)*((x)-3)*((x)-5)/24. |
#define | q65(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)/120. |
#define | q70(x) ((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)/720. |
#define | q71(x) -(x)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)/120. |
#define | q72(x) (x)*((x)-1)*((x)-3)*((x)-4)*((x)-5)*((x)-6)/48. |
#define | q73(x) -(x)*((x)-1)*((x)-2)*((x)-4)*((x)-5)*((x)-6)/36. |
#define | q74(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-5)*((x)-6)/48. |
#define | q75(x) -(x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-6)/120. |
#define | q76(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)/720. |
#define | q80(x) -((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-7)/5040. |
#define | q81(x) (x)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-7)/720. |
#define | q82(x) -(x)*((x)-1)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-7)/240. |
#define | q83(x) (x)*((x)-1)*((x)-2)*((x)-4)*((x)-5)*((x)-6)*((x)-7)/144. |
#define | q84(x) -(x)*((x)-1)*((x)-2)*((x)-3)*((x)-5)*((x)-6)*((x)-7)/144. |
#define | q85(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-6)*((x)-7)/240. |
#define | q86(x) -(x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-7)/720. |
#define | q87(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)/5040. |
#define | q90(x) ((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-7)*((x)-8)/40320. |
#define | q91(x) -(x)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-7)*((x)-8)/5040. |
#define | q92(x) (x)*((x)-1)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-7)*((x)-8)/1440. |
#define | q93(x) -(x)*((x)-1)*((x)-2)*((x)-4)*((x)-5)*((x)-6)*((x)-7)*((x)-8)/720. |
#define | q94(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-5)*((x)-6)*((x)-7)*((x)-8)/576. |
#define | q95(x) -(x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-6)*((x)-7)*((x)-8)/720. |
#define | q96(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-7)*((x)-8)/1440. |
#define | q97(x) -(x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-8)/5040. |
#define | q98(x) (x)*((x)-1)*((x)-2)*((x)-3)*((x)-4)*((x)-5)*((x)-6)*((x)-7)/40320. |
#define | IL(i0, i1) ipp[i0+ipDim0*(i1)] |
#define | VIW(i) viw(i) |
#define | IL1(i) IL(i,0) |
#define | IL2(i) IL(i,1) |
#define | IL3(i) IL(i,2) |
#define | CI(i0, i1) cip[i0+ciDim0*(i1)] |
#define | UI(i0, i1) uip[i0+uiDim0*(i1)] |
#define | IA(i0) iap[(i0)] |
#define | cf(i, m1, m2) coeffap[i+nil*((m1)+width[0]*((m2)))] |
#define | cfs(i, m1) coeffap[i+nil*(m1)] |
#define | MASK(i0, i1, i2) maskp[i0+maskDim0*(i1+maskDim1*(i2))] |
#define | VS(i0, i1, i2) vsp[i0+vsDim0*(i1+vsDim1*(i2))] |
#define | IW5(m1) (cf(j,0,m1)*VS(il0 ,il1+m1,c1)+cf(j,1,m1)*VS(il0+1,il1+m1,c1)+cf(j,2,m1)*VS(il0+2,il1+m1,c1)+cf(j,3,m1)*VS(il0+3,il1+m1,c1)+cf(j,4,m1)*VS(il0+4,il1+m1,c1)) |
#define | c(i, m1, m2, m3) coeffgp[m1+width[0]*(m2+width[1]*m3)][i] |
#define | VS(i0, i1, i2, i3) vsp[i0+vsDim0*(i1+vsDim1*(i2+vsDim2*(i3)))] |
#define | c(i, m1, m2, m3) coeffap[i+nil*((m1)+width[0]*((m2)+width[1]*(m3)))] |
#define | IW5A(m1, m2) (c(j,0,m1,m2)*VS(il0 ,il1+m1,il2+m2,c1)+c(j,1,m1,m2)*VS(il0+1,il1+m1,il2+m2,c1)+c(j,2,m1,m2)*VS(il0+2,il1+m1,il2+m2,c1)+c(j,3,m1,m2)*VS(il0+3,il1+m1,il2+m2,c1)+c(j,4,m1,m2)*VS(il0+4,il1+m1,il2+m2,c1)) |
#define | IW5(m2) (IW5A(0,m2)+IW5A(1,m2)+IW5A(2,m2)+IW5A(3,m2)+IW5A(4,m2)) |
#define c | ( | i, | |
m1, | |||
m2, | |||
m3 | |||
) | coeffgp[m1+width[0]*(m2+width[1]*m3)][i] |
Referenced by TrimmedMapping::addTrimCurve(), MappedGridOperators::applyBCaDotGradU(), MappedGridOperators::applyBCaDotU(), UnstructuredOperators::applyBCdirichlet(), MappedGridOperators::applyBCdirichlet(), MappedGridOperators::applyBCextrapolate(), MappedGridOperators::applyBCGenDiv(), MappedGridOperators::applyBCgeneralMixedDerivative(), MappedGridOperators::applyBCneumann(), MappedGridOperators::applyBCnormalComponent(), MappedGridOperators::applyBCnormalDerivative(), MappedGridOperators::applyBCnormalDotScalarGrad(), MappedGridOperators::applyBCsymmetry(), MappedGridOperators::applyBCtangentialComponent(), MappedGridOperators::applyBoundaryCondition(), MappedGridOperators::applyBoundaryConditionCoefficients(), Ogmg::applyBoundaryConditions(), StretchTransform::applyStretching(), TrimmedMapping::assembleSubCurves(), AssignInterpNeighbours::assign(), RevolutionMapping::basicInverse(), RestrictionMapping::basicInverse(), TrimmedMapping::basicInverse(), RevolutionMapping::basicInverseS(), RestrictionMapping::basicInverseS(), Ogen::buildACompositeGrid(), CompositeTopology::buildEdgeCurves(), buildEdgeCurves(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), OffsetShell::buildOffsetMappings(), StretchTransform::buildStretchingParametersDialog(), NurbsMapping::buildSubCurves(), MappingBuilder::buildSurfacePatch(), Ogen::changeParameters(), Ogen::checkUpdateRefinement(), Ogen::classifyPoints(), MappedGridOperators::computeDerivatives(), ErrorEstimator::computeErrorFunction(), ErrorEstimator::computeFunction(), Ogen::computeInterpolationQuality(), MeshQualityMetrics::computeJacobian(), MeshQualityMetrics::computeJacobianProperties(), Integrate::computeLeftNullVector(), Ogmg::computeLeftNullVector(), Integrate::computeSurfaceWeights(), AdvancingFront::computeVertexCandidates(), MeshQualityMetrics::computeWeight(), Integrate::computeWeights(), Ogen::conformToCmpgrd(), PlotIt::contour2d(), PlotIt::contour3d(), PlotIt::contourCuts(), MappingsFromCAD::createBoundaryEntity(), MappingsFromCAD::createManifoldSolidBRepObject(), Ogmg::createNullVector(), TrimmedMapping::curveGoesThrough(), TrimmedMapping::deleteTrimCurve(), derivativeScalarDerivativeFDerivCoefficients(), Oges::determineErrors(), displayCoeff(), ErrorEstimator::displayParameters(), TMquad::distanceToCurve(), UNSTRUCTURED_OPS_FV2::divergence_uFV2(), divScalarGradFDerivCoefficients(), divVectorScalarFDerivCoefficients(), dudt(), TrimmedMapping::editNurbsTrimCurve(), Ogen::findBestGuess(), UnstructuredMapping::findBoundaryCurves(), TrimmedMapping::findClosestCurve(), Oges::findExtraEquations(), CompositeSurface::findOutwardTangent(), RotatedBox::fitBox(), GenericMappedGridOperators::fixBoundaryCorners(), SparseRepForMGF::fixUpClassify(), TriangleWrapper::generate(), Ogen::generateInterpolationArrays(), Oges::generateMatrix(), Ogmg::getDefect(), getLine(), getLineFromFile(), floatGridCollectionFunction::getName(), doubleGridCollectionFunction::getName(), intGridCollectionFunction::getName(), floatMappedGridFunction::getName(), doubleMappedGridFunction::getName(), intMappedGridFunction::getName(), TrimmedMapping::getNumberOfBoundarySubCurves(), CompositeCurve::getRangeBound(), getTimeStep(), getTrueSolution(), PlotIt::grid3d(), identityFDerivCoefficients(), Ogen::improveQuality(), ExposedPoints::initialize(), FilletMapping::initialize(), Ogmg::initializeBoundaryConditions(), Ogmg::initializeConstantCoefficients(), TrimmedMapping::initializeQuadTree(), ParallelOverlappingGridInterpolator::internalInterpolate(), InterpolatePointsOnAGrid::internalInterpolate(), Ogen::interpolateAll(), InterpolateRefinements::interpolateCoarseFromFine(), Interpolate::interpolateCoarseFromFine(), interpolateExposedPoints(), NurbsMapping::interpolateLoftedSurface(), InterpolateRefinements::interpolateRefinementBoundaries(), StretchMapping::inverseMapS(), UnstructuredMapping::isDuplicateNode(), Ogmg::l2Error(), l2Norm(), Ogmg::l2Norm(), laplaceFDerivCoefficients(), Ogen::lastChanceInterpolation(), EllipticGridGenerator::lineSmoother(), lpNorm(), main(), Oges::makeRightNullVector(), AdvancingFront::makeTriOnSurface(), makeTriTetFromNewVertex(), RevolutionMapping::map(), FilletMapping::map(), TrimmedMapping::map(), TrimmedMapping::mapGrid(), RevolutionMapping::mapS(), StretchMapping::mapS(), Ogen::markPointsNeededForInterpolation(), Ogen::markPointsNeededForInterpolationNew(), Ogen::markPointsReallyNeededForInterpolation(), maxNorm(), Ogmg::maxNorm(), NurbsMapping::merge(), Ogen::movingUpdate(), Ogen::movingUpdateNew(), IntersectionMapping::newtonIntersection(), ogen(), NurbsMapping::operator=(), TMcurves::operator=(), Ogmg::operatorAveraging(), outputLatexTable(), outputMovingGrids(), outputRefinementInfo(), outputRefinementInfoNew(), InterpolatePointsOnAGrid::parallelInternalInterpolate(), EllipticGridGenerator::periodicUpdate(), floatMappedGridFunction::periodicUpdate(), intMappedGridFunction::periodicUpdate(), doubleMappedGridFunction::periodicUpdate(), PlotIt::plot(), PlotIt::plotGrid(), Ogen::preInterpolateGrids(), Ugen::preprocessCompositeGridMasks(), QuadraticMapping::put(), CrossSectionMapping::put(), CompositeTopology::put(), Ogen::queryAPoint(), NurbsMapping::readFromIgesFile(), MappingsFromCAD::readOneCurve(), MappingsFromCAD::readSomeNurbs(), TMquad::remake(), TrimmedMapping::reportTrimmingInfo(), rot3d(), saveOvertureTextFile(), Ogshow::saveSequence(), Oges::setEquationAndBoundaryConditions(), doubleMappedGridFunction::setFaceCentering(), floatMappedGridFunction::setFaceCentering(), intMappedGridFunction::setFaceCentering(), floatGridCollectionFunction::setName(), intGridCollectionFunction::setName(), doubleGridCollectionFunction::setName(), floatMappedGridFunction::setName(), intMappedGridFunction::setName(), doubleMappedGridFunction::setName(), JoinMapping::setup(), FilletMapping::setupForNewCurves(), showFileFromDataFile(), Ogmg::smoothBoundary(), Ogmg::smoothInterpolationNeighbours(), Ogmg::smoothJacobi(), Ogmg::smoothLine(), Ogmg::smoothRedBlack(), NurbsMapping::split(), PlotIt::surfaceGrid3d(), Integrate::surfaceIntegral(), Triangle::tetrahedralVolume(), TMcurves::TMcurves(), TrimmedMapping::triangulate(), UNSTRUCTURED_OPS_FV2::u_divergence_uFV2(), UNSTRUCTURED_OPS_FV2::u_xi_uFV2(), UNSTRUCTURED_OPS_FV2::u_xixj_uFV2(), TrimmedMapping::undoLastDelete(), Ogen::unmarkBoundaryInterpolationPoints(), Ogen::unmarkInterpolationPoints(), StretchTransform::update(), FilletMapping::update(), ErrorEstimator::update(), DerivedFunctions::update(), FilamentMapping::update(), TrimmedMapping::update(), NurbsMapping::update(), Ogen::updateCanInterpolate(), StretchTransform::updateStretchingParameters(), SparseRepForMGF::updateToMatchGrid(), PlotIt::userDefinedOutput(), TrimmedMapping::validateTrimming(), Integrate::volume(), Integrate::volumeIntegral(), xFDerivCoefficients(), UNSTRUCTURED_OPS_FV2::xi_uFV2(), MappedGridOperators::xiCoefficients(), UNSTRUCTURED_OPS_FV2::xixj_uFV2(), xxFDerivCoefficients(), xyFDerivCoefficients(), xzFDerivCoefficients(), yFDerivCoefficients(), yyFDerivCoefficients(), yzFDerivCoefficients(), zFDerivCoefficients(), zzFDerivCoefficients(), MappingBuilder::~MappingBuilder(), and NurbsMapping::~NurbsMapping().
#define c | ( | i, | |
m1, | |||
m2, | |||
m3 | |||
) | coeffap[i+nil*((m1)+width[0]*((m2)+width[1]*(m3)))] |
#define cf | ( | i, | |
m1, | |||
m2 | |||
) | coeffap[i+nil*((m1)+width[0]*((m2)))] |
Referenced by Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), EllipticGridGenerator::coarseToFine(), Ogmg::coarseToFine(), EllipticGridGenerator::fineToCoarse(), Ogmg::fineToCoarse(), Ugen::generateSpacingControlMesh(), Ogmg::getInterpolationCoordinatesNew(), Ogmg::getInterpolationCoordinatesNewOld(), ParallelOverlappingGridInterpolator::internalInterpolate(), InterpolatePointsOnAGrid::internalInterpolate(), Ogmg::operatorAveraging(), and InterpolatePointsOnAGrid::parallelInternalInterpolate().
#define cfs | ( | i, | |
m1 | |||
) | coeffap[i+nil*(m1)] |
#define CI | ( | i0, | |
i1 | |||
) | cip[i0+ciDim0*(i1)] |
#define CI | ( | i0, | |
i1 | |||
) | cip[i0+ciDim0*(i1)] |
#define coeffg | ( | i, | |
m1, | |||
m2, | |||
m3 | |||
) | coeffap[i+nil*((m1)+width[0]*((m2)+width[1]*(m3)))] |
#define dr | ( | axis | ) | drp[axis] |
#define IA | ( | i0 | ) | iap[(i0)] |
#define IL | ( | i0, | |
i1 | |||
) | ipp[i0+ipDim0*(i1)] |
#define IL | ( | i0, | |
i1 | |||
) | ipp[i0+ipDim0*(i1)] |
#define IL1 | ( | i | ) | IL(i,0) |
#define IL2 | ( | i | ) | IL(i,1) |
#define IL3 | ( | i | ) | IL(i,2) |
#define ir | ( | side, | |
axis | |||
) | irp[side+2*(axis)] |
#define isCC | ( | axis | ) | isCellCenteredp[axis] |
#define IW5A | ( | m1, | |
m2 | |||
) | (c(j,0,m1,m2)*VS(il0 ,il1+m1,il2+m2,c1)+c(j,1,m1,m2)*VS(il0+1,il1+m1,il2+m2,c1)+c(j,2,m1,m2)*VS(il0+2,il1+m1,il2+m2,c1)+c(j,3,m1,m2)*VS(il0+3,il1+m1,il2+m2,c1)+c(j,4,m1,m2)*VS(il0+4,il1+m1,il2+m2,c1)) |
#define q | ( | axis, | |
m | |||
) | qp[axis+3*(m)] |
#define q10 | ( | x | ) | 1 |
#define UI | ( | i0, | |
i1 | |||
) | uip[i0+uiDim0*(i1)] |
#define VIW | ( | i | ) | viw(i) |
#define VIW | ( | i | ) | viw(i) |