Overture
Version 25
|
#include <Integrate.h>
Public Member Functions | |
Integrate () | |
Integrate (CompositeGrid &cg) | |
~Integrate () | |
int | computeAllWeights () |
int | defineSurface (const int &surfaceNumber, const int &numberOfFaces_, IntegerArray &boundary) |
int | defineSurfacesAndComputeWeights (GenericGraphicsInterface &gi) |
Interactively define surfaces and compute weights. | |
int | get (const GenericDataBase &dir, const aString &name) |
Get the Integrate object from the directory "name" of the data base. | |
int | getFace (const int surfaceNumber, const int face, int &side, int &axis, int &grid) const |
const BodyDefinition & | getBodyDefinition () const |
int | numberOfFacesOnASurface (const int surfaceNumber) const |
SurfaceStitcher * | getSurfaceStitcher () const |
int | put (GenericDataBase &dir, const aString &name) const |
Put this Integrate object in a sub-directory called "name" of the data base. | |
void | setDeleteSolverAfterUse (bool trueOrFalse) |
void | setInteractiveStitching (bool trueOrFalse) |
void | setRadialAxis (int axis) |
int | setTolerance (const real tol) |
real | surfaceArea (const int &surfaceNumber=-1) |
real | surfaceIntegral (const RealCompositeGridFunction &u, const int &surfaceNumber=-1) |
int | surfaceIntegral (const RealCompositeGridFunction &u, const Range &C, RealArray &integral, const int &surfaceNumber=-1) |
int | updateToMatchGrid (CompositeGrid &cg) |
void | useAdaptiveMeshRefinementGrids (bool trueOrFalse=true) |
void | useHybridGrids (bool trueOrFalse=true) |
int | updateForAMR (CompositeGrid &cg) |
real | volume () |
real | volumeIntegral (const RealCompositeGridFunction &u, const int component=0) |
int | volumeIntegral (const RealCompositeGridFunction &u, const Range &C, RealArray &integral) |
RealCompositeGridFunction & | integrationWeights () |
RealCompositeGridFunction & | leftNullVector () |
Static Public Attributes | |
static int | debug =0 |
Protected Member Functions | |
int | initialize () |
int | computeWeights () |
Compute the integration weights. This is a protected routine. | |
int | computeSurfaceWeights (int surfaceNumber=-1) |
int | computeLeftNullVector () |
int | surfaceIndex (int surfaceNumber) |
int | computeStitchedSurfaceWeightsOld () |
int | computeStitchedSurfaceWeights (int surfaceNumber=-1) |
int | buildAdaptiveMeshRefinementSurfaceWeights (CompositeGrid &cgu, const int &surfaceNumber=-1) |
int | destroyAdaptiveMeshRefinementIntegrationArrays () |
Protected Attributes | |
aString | className |
bool | useSurfaceStitching |
bool | interactiveStitcher |
SurfaceStitcher * | pSurfaceStitcher |
BodyDefinition | bd |
CompositeGrid | cg |
int | orderOfAccuracy |
IntegerArray | boundaryHasOverlap |
IntegerArray | faceWeightsDefined |
IntegerArray | surfaceWeightsDefined |
realCompositeGridFunction | weights |
realCompositeGridFunction | nullVector |
Oges * | solver |
real | tolerance |
bool | weightsComputed |
bool | leftNullVectorComputed |
bool | allFaceWeightsDefined |
bool | weightsUpdatedToMatchGrid |
bool | deleteSolverAfterUse |
bool | useAMR |
int * | numberOfFacesPerSurface |
int | numberOfBoundarySurfaces |
int | numberOfBoundaryRefinementLevels |
int * | numberOfBoundaryFaces |
RealArray *** | boundaryWeights |
int ** | pNumberOfBoundaryGrids |
int *** | pBoundaryGrid |
int | radialAxis |
FILE * | debugFile |
Integrate::Integrate | ( | ) |
References debugFile, initialize(), and NULL.
Integrate::Integrate | ( | CompositeGrid & | cg | ) |
References debugFile, initialize(), NULL, and updateToMatchGrid().
Integrate::~Integrate | ( | ) |
References debugFile, destroyAdaptiveMeshRefinementIntegrationArrays(), NULL, pSurfaceStitcher, and solver.
|
protected |
References axis1, axis2, GenericGridCollection::baseGridNumber, bd, boundaryCondition, BodyDefinition::boundaryFaces, boundaryGrid, boundaryWeights, bWeights, MappedGrid::centerJacobian(), debugFile, destroyAdaptiveMeshRefinementIntegrationArrays(), display(), fabs(), getBoundaryIndex(), getGhostIndex(), ParallelUtility::getLocalArrayBounds(), getLocalArrayWithGhostBoundaries(), MappedGrid::gridIndexRange(), gridIndexRange, GenericGridCollection::gridNumber, gridSpacing, MappedGrid::gridSpacing(), MappedGrid::inverseVertexDerivative(), mask, MappedGrid::mask(), NULL, numberOfBoundaryFaces, numberOfBoundaryGrids, numberOfBoundaryRefinementLevels, numberOfBoundarySurfaces, GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), BodyDefinition::numberOfFaces, numberOfFacesPerSurface, GenericGridCollection::numberOfRefinementLevels(), BodyDefinition::numberOfSurfaces, OV_ABORT, pBoundaryGrid, pNumberOfBoundaryGrids, printF(), GridCollection::refinementLevel, rx, RXB, s, sPrintF(), SQR, SQRT, BodyDefinition::surfaceIndex(), MappedGrid::THEcenterJacobian, MappedGrid::THEinverseVertexDerivative, MappedGrid::update(), and weights.
Referenced by surfaceIntegral(), and updateForAMR().
int Integrate::computeAllWeights | ( | ) |
References computeWeights(), printF(), and weightsComputed.
Referenced by ogen().
|
protected |
References BCTypes::allBoundaries, doubleCompositeGridFunction::applyBoundaryConditionCoefficients(), SparseRepForMGF::boundary, c, cg, MappedGrid::dimension(), discretizationWidth, doubleGridCollectionFunction::display(), Oges::equationToIndex(), Oges::extraEquationNumber, BCTypes::extrapolate, doubleCompositeGridFunction::finishBoundaryConditions(), getIndex(), SparseRepForMGF::ghost1, BoundaryConditionParameters::ghostLineToAssign, Oges::initialize(), SparseRepForMGF::interior, leftNullVectorComputed, mask, max(), min(), BCTypes::neumann, nullVector, GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), orderOfAccuracy, BoundaryConditionParameters::orderOfExtrapolation, pow(), Oges::set(), Oges::setCoefficientArray(), doubleCompositeGridFunction::setIsACoefficientMatrix(), doubleCompositeGridFunction::setOperators(), GenericCompositeGridOperators::setOrderOfAccuracy(), GenericCompositeGridOperators::setStencilSize(), Oges::solve(), solver, doubleGridCollectionFunction::sparse, OgesParameters::THEbestIterativeSolver, OgesParameters::THEcompatibilityConstraint, OgesParameters::THEfixupRightHandSide, OgesParameters::THEsolveForTranspose, OgesParameters::THEtolerance, tolerance, doubleCompositeGridFunction::updateToMatchGrid(), Oges::updateToMatchGrid(), and weights.
Referenced by leftNullVector().
|
protected |
References Overture::abort(), allFaceWeightsDefined, AREA1, AREA2, AREA3, assert, axis1, axis2, bd, MappedGrid::boundaryFlag(), InterpolatePoints::buildInterpolationInfo(), MappedGrid::centerJacobian(), cg, BodyDefinition::defineSurface(), SurfaceStitcher::defineSurfaces(), MappedGrid::discretizationWidth(), displayMask(), MappedGrid::domainDimension(), SurfaceStitcher::enlargedHoleMask, SurfaceStitcher::enlargeGap(), UnstructuredMapping::Face, faceWeightsDefined, FOR_3IJD, getBoundaryIndex(), UnstructuredMapping::getEntities(), BodyDefinition::getFace(), getGhostIndex(), getIndex(), InterpolatePoints::getInterpolationInfo(), UnstructuredMapping::getNodes(), SurfaceStitcher::getSurfaceCompositeGrid(), SurfaceStitcher::getUnstructuredGrid(), MappedGrid::gridIndexRange(), gridSpacing, MappedGrid::gridSpacing(), i2, interactiveStitcher, InterpolatePoints::interpolationCoefficients(), CompositeGrid::interpolationIsImplicit, CompositeGrid::interpolationWidth, interpoleeGrid, MappedGrid::inverseVertexDerivative(), mask, MappedGrid::mask(), max(), MappedGrid::mixedPhysicalInterpolationBoundary, NULL, GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), BodyDefinition::numberOfFacesOnASurface(), GenericGridCollection::numberOfGrids(), SurfaceStitcher::originalMask, MappedGrid::physicalBoundary, printF(), pSurfaceStitcher, GenericGridCollection::refinementLevelNumber, rx, SurfaceStitcher::setMask(), MappedGrid::sharedBoundaryFlag(), UnstructuredMapping::size(), sPrintF(), SurfaceStitcher::stitchSurfaceCompositeGrid(), surfaceWeightsDefined, MappedGrid::THEcenterJacobian, MappedGrid::THEinverseVertexDerivative, BodyDefinition::totalNumberOfSurfaces(), MappedGrid::update(), doubleCompositeGridFunction::updateToMatchGrid(), weights, and weightsUpdatedToMatchGrid.
Referenced by computeSurfaceWeights().
|
protected |
References Overture::abort(), allFaceWeightsDefined, axis1, axis2, axis3, MappedGrid::boundaryCondition(), InterpolatePoints::buildInterpolationInfo(), MappedGrid::centerJacobian(), cg, SurfaceStitcher::defineSurfaces(), MappedGrid::discretizationWidth(), MappedGrid::domainDimension(), dr, SurfaceStitcher::enlargeGap(), fabs(), UnstructuredMapping::Face, faceWeightsDefined, getBoundaryIndex(), UnstructuredMapping::getEntities(), getGhostIndex(), getIndex(), InterpolatePoints::getInterpolationInfo(), UnstructuredMapping::getNodes(), CompositeGrid::getSurfaceStitching(), SurfaceStitcher::getUnstructuredGrid(), gid, MappedGrid::gridIndexRange(), gridSpacing, MappedGrid::gridSpacing(), i2, interactiveStitcher, InterpolatePoints::interpolationCoefficients(), CompositeGrid::interpolationIsImplicit, CompositeGrid::interpolationWidth, interpoleeGrid, MappedGrid::inverseVertexDerivative(), KRX, mask, MappedGrid::mask(), max(), GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), GenericGridCollection::numberOfGrids(), GenericGridCollection::refinementLevelNumber, rx, CompositeGrid::setSurfaceStitching(), MappedGrid::sharedBoundaryFlag(), UnstructuredMapping::size(), SQR, SQRT, SurfaceStitcher::stitchSurfaceCompositeGrid(), surfaceWeightsDefined, MappedGrid::THEcenterJacobian, MappedGrid::THEinverseVertexDerivative, MappedGrid::update(), doubleCompositeGridFunction::updateToMatchGrid(), weights, and weightsUpdatedToMatchGrid.
|
protected |
References Overture::abort(), allFaceWeightsDefined, assert, axis1, axis2, axis3, bd, boundaryCondition, MappedGrid::boundaryCondition(), BodyDefinition::boundaryFaces, boundaryHasOverlap, c, MappedGrid::centerJacobian(), cg, computeStitchedSurfaceWeights(), debugFile, dr, End, MappedGrid::extendedIndexRange(), fabs(), faceWeightsDefined, getBoundaryIndex(), getGhostIndex(), ParallelUtility::getLocalArrayBounds(), getLocalArrayWithGhostBoundaries(), MappedGrid::getName(), ParallelUtility::getSum(), MappedGrid::gridIndexRange(), gridSpacing, MappedGrid::gridSpacing(), MappedGrid::inverseVertexDerivative(), mask, MappedGrid::mask(), NULL, GenericGridCollection::numberOfBaseGrids(), GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), BodyDefinition::numberOfFaces, BodyDefinition::numberOfSurfaces, printF(), rx, RXLocal, s, SQR, SQRT, Start, BodyDefinition::surfaceIndex(), surfaceWeightsDefined, MappedGrid::THEcenterJacobian, MappedGrid::THEinverseVertexDerivative, MappedGrid::THEmask, MappedGrid::update(), doubleCompositeGridFunction::updateToMatchGrid(), useSurfaceStitching, weights, and weightsUpdatedToMatchGrid.
Referenced by computeWeights(), defineSurfacesAndComputeWeights(), and surfaceIntegral().
|
protected |
Compute the integration weights. This is a protected routine.
This routine will solve for all the surface and volume weights by solving a linear system of equations.
References BCTypes::allBoundaries, allFaceWeightsDefined, doubleCompositeGridFunction::applyBoundaryConditionCoefficients(), axis1, axis2, axis3, SparseRepForMGF::boundary, MappedGrid::boundaryCondition(), boundaryHasOverlap, c, MappedGrid::center(), CENTER, center, MappedGrid::centerJacobian(), cg, CLASSIFY, COEFF, coeffg, computeSurfaceWeights(), debugFile, deleteSolverAfterUse, MappedGrid::dimension(), doubleGridCollectionFunction::display(), displayCoeff(), dr, End, MappedGrid::extendedIndexRange(), BCTypes::extrapolate, F, fabs(), faceWeightsDefined, doubleCompositeGridFunction::finishBoundaryConditions(), FOR_3D, FOR_3IJD, getBoundaryIndex(), getCPU(), getGhostIndex(), getIndex(), ParallelUtility::getLocalArrayBounds(), getLocalArrayWithGhostBoundaries(), Oges::getMaximumResidual(), MappedGrid::getName(), OgesParameters::getSolverName(), ParallelUtility::getSum(), SparseRepForMGF::ghost1, BoundaryConditionParameters::ghostLineToAssign, GID, MappedGrid::gridIndexRange(), gridIndexRange, gridSpacing, MappedGrid::gridSpacing(), i2, MappedGrid::indexRange(), SparseRepForMGF::interior, MappedGrid::inverseVertexDerivative(), JACOBIAN, MappedGridOperators::laplacianOperator, M, M2, M3, mask, MASK, MappedGrid::mask(), BCTypes::neumann, NULL, Overture::nullRealDistributedArray(), GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), orderOfAccuracy, BoundaryConditionParameters::orderOfExtrapolation, OV_ABORT, Oges::parameters, pow(), printF(), radialAxis, rx, RXLocal, s, Oges::set(), Oges::setCoefficientArray(), doubleCompositeGridFunction::setIsACoefficientMatrix(), doubleCompositeGridFunction::setOperators(), GenericCompositeGridOperators::setOrderOfAccuracy(), GenericCompositeGridOperators::setStencilSize(), Oges::solve(), solver, doubleGridCollectionFunction::sparse, SQR, SQRT, Start, surfaceWeightsDefined, OgesParameters::THEbestIterativeSolver, MappedGrid::THEcenter, MappedGrid::THEcenterJacobian, OgesParameters::THEfixupRightHandSide, MappedGrid::THEinverseVertexDerivative, OgesParameters::THErescaleRowNorms, OgesParameters::THEsolveForTranspose, OgesParameters::THEtolerance, MappedGrid::THEvertexBoundaryNormal, tolerance, CompositeGrid::update(), doubleCompositeGridFunction::updateToMatchGrid(), Oges::updateToMatchGrid(), weights, WEIGHTS, weightsComputed, and weightsUpdatedToMatchGrid.
Referenced by computeAllWeights(), defineSurfacesAndComputeWeights(), integrationWeights(), surfaceIntegral(), volume(), and volumeIntegral().
int Integrate::defineSurface | ( | const int & | surfaceNumber, |
const int & | numberOfFaces_, | ||
IntegerArray & | boundary | ||
) |
int Integrate::defineSurfacesAndComputeWeights | ( | GenericGraphicsInterface & | gi | ) |
Interactively define surfaces and compute weights.
References GenericGraphicsInterface::appendToTheDefaultPrompt(), assert, aString, bd, cg, computeSurfaceWeights(), computeWeights(), defineSurface(), GenericGraphicsInterface::erase(), GenericGraphicsInterface::getAnswer(), MappedGrid::getName(), SurfaceStitcher::getSurfaceCompositeGrid(), DialogData::getTextValue(), DialogData::getToggleValue(), GI_LABEL_GRIDS_AND_BOUNDARIES, GI_PLOT_THE_OBJECT_AND_EXIT, NULL, GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), GenericGraphicsInterface::outputString(), PlotIt::plot(), GenericGraphicsInterface::popGUI(), printF(), pSurfaceStitcher, GenericGraphicsInterface::pushGUI(), GraphicsParameters::set(), DialogData::setExitCommand(), DialogData::setPushButtons(), DialogData::setTextBoxes(), DialogData::setToggleButtons(), DialogData::setWindowTitle(), share, MappedGrid::sharedBoundaryFlag(), sPrintF(), GenericGraphicsInterface::stopReadingCommandFile(), surfaceArea(), surfaceIntegral(), surfaceWeightsDefined, tolerance, BodyDefinition::totalNumberOfSurfaces(), GenericGraphicsInterface::unAppendTheDefaultPrompt(), useSurfaceStitching, volume(), volumeIntegral(), and weightsComputed.
|
protected |
int Integrate::get | ( | const GenericDataBase & | dir, |
const aString & | name | ||
) |
Get the Integrate object from the directory "name" of the data base.
References allFaceWeightsDefined, bd, boundaryHasOverlap, cg, className, faceWeightsDefined, GenericDataBase::find(), BodyDefinition::get(), GenericDataBase::get(), doubleGridCollectionFunction::get(), leftNullVectorComputed, orderOfAccuracy, printF(), radialAxis, surfaceWeightsDefined, doubleCompositeGridFunction::updateToMatchGrid(), useAMR, useSurfaceStitching, GenericDataBase::virtualConstructor(), weights, weightsComputed, and weightsUpdatedToMatchGrid.
const BodyDefinition & Integrate::getBodyDefinition | ( | ) | const |
References bd.
int Integrate::getFace | ( | const int | surfaceNumber, |
const int | face, | ||
int & | side, | ||
int & | axis, | ||
int & | grid | ||
) | const |
References assert, boundaryGrid, NULL, and numberOfBoundaryGrids.
SurfaceStitcher * Integrate::getSurfaceStitcher | ( | ) | const |
References pSurfaceStitcher.
|
protected |
References allFaceWeightsDefined, boundaryWeights, className, debug, debugFile, deleteSolverAfterUse, interactiveStitcher, leftNullVectorComputed, max(), NULL, numberOfBoundaryFaces, numberOfBoundaryRefinementLevels, numberOfBoundarySurfaces, numberOfFacesPerSurface, orderOfAccuracy, pBoundaryGrid, pNumberOfBoundaryGrids, pSurfaceStitcher, radialAxis, REAL_EPSILON, solver, sPrintF(), tolerance, useAMR, useSurfaceStitching, weightsComputed, and weightsUpdatedToMatchGrid.
Referenced by Integrate().
RealCompositeGridFunction & Integrate::integrationWeights | ( | ) |
References computeWeights(), weights, and weightsComputed.
RealCompositeGridFunction & Integrate::leftNullVector | ( | ) |
References computeLeftNullVector(), leftNullVectorComputed, and nullVector.
Referenced by Ogmg::computeLeftNullVector(), and main().
int Integrate::numberOfFacesOnASurface | ( | const int | surfaceNumber | ) | const |
int Integrate::put | ( | GenericDataBase & | dir, |
const aString & | name | ||
) | const |
Put this Integrate object in a sub-directory called "name" of the data base.
References allFaceWeightsDefined, bd, boundaryHasOverlap, className, GenericDataBase::create(), faceWeightsDefined, leftNullVectorComputed, orderOfAccuracy, OV_ABORT, printF(), BodyDefinition::put(), GenericDataBase::put(), doubleGridCollectionFunction::put(), radialAxis, surfaceWeightsDefined, useAMR, useSurfaceStitching, GenericDataBase::virtualConstructor(), weights, weightsComputed, and weightsUpdatedToMatchGrid.
Referenced by ogen().
void Integrate::setDeleteSolverAfterUse | ( | bool | trueOrFalse | ) |
References deleteSolverAfterUse.
void Integrate::setInteractiveStitching | ( | bool | trueOrFalse | ) |
References interactiveStitcher.
void Integrate::setRadialAxis | ( | int | axis | ) |
References radialAxis.
real Integrate::surfaceArea | ( | const int & | surfaceNumber = -1 | ) |
References C, cg, and surfaceIntegral().
Referenced by defineSurfacesAndComputeWeights().
|
protected |
References bd, and BodyDefinition::surfaceIndex().
real Integrate::surfaceIntegral | ( | const RealCompositeGridFunction & | u, |
const int & | surfaceNumber = -1 |
||
) |
References C.
Referenced by defineSurfacesAndComputeWeights(), and surfaceArea().
int Integrate::surfaceIntegral | ( | const RealCompositeGridFunction & | u, |
const Range & | C, | ||
RealArray & | integral, | ||
const int & | surfaceNumber = -1 |
||
) |
References allFaceWeightsDefined, bd, boundaryCondition, MappedGrid::boundaryCondition(), BodyDefinition::boundaryFaces, boundaryGrid, buildAdaptiveMeshRefinementSurfaceWeights(), bWeights, c, cg, computeSurfaceWeights(), computeWeights(), display(), End, getBoundaryIndex(), doubleCompositeGridFunction::getCompositeGrid(), getGhostIndex(), ParallelUtility::getLocalArrayBounds(), getLocalArrayWithGhostBoundaries(), ParallelUtility::getSums(), gridIndexRange, max(), GenericGridCollection::numberOfBaseGrids(), numberOfBoundaryGrids, GridCollection::numberOfDimensions(), BodyDefinition::numberOfFaces, GenericGridCollection::numberOfRefinementLevels(), BodyDefinition::numberOfSurfaces, printF(), sPrintF(), Start, BodyDefinition::surfaceIndex(), surfaceWeightsDefined, useAMR, and weights.
int Integrate::updateForAMR | ( | CompositeGrid & | cg | ) |
int Integrate::updateToMatchGrid | ( | CompositeGrid & | cg | ) |
References allFaceWeightsDefined, boundaryHasOverlap, cg, debug, discretizationWidth, faceWeightsDefined, max(), min(), GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), orderOfAccuracy, printF(), CompositeGrid::reference(), surfaceWeightsDefined, weightsComputed, and weightsUpdatedToMatchGrid.
Referenced by Integrate().
void Integrate::useAdaptiveMeshRefinementGrids | ( | bool | trueOrFalse = true | ) |
void Integrate::useHybridGrids | ( | bool | trueOrFalse = true | ) |
References useSurfaceStitching.
real Integrate::volume | ( | ) |
References c, cg, computeWeights(), FOR_3D, getIndex(), ParallelUtility::getLocalArrayBounds(), getLocalArrayWithGhostBoundaries(), ParallelUtility::getSum(), MappedGrid::gridIndexRange(), i2, GenericGridCollection::numberOfBaseGrids(), volumeIntegral(), weights, WEIGHTS, and weightsComputed.
Referenced by defineSurfacesAndComputeWeights().
real Integrate::volumeIntegral | ( | const RealCompositeGridFunction & | u, |
const int | component = 0 |
||
) |
References C.
Referenced by defineSurfacesAndComputeWeights(), and volume().
int Integrate::volumeIntegral | ( | const RealCompositeGridFunction & | u, |
const Range & | C, | ||
RealArray & | integral | ||
) |
|
protected |
|
protected |
|
protected |
Referenced by computeSurfaceWeights(), computeWeights(), get(), put(), and updateToMatchGrid().
|
protected |
|
protected |
Referenced by computeLeftNullVector(), computeStitchedSurfaceWeights(), computeStitchedSurfaceWeightsOld(), computeSurfaceWeights(), computeWeights(), defineSurfacesAndComputeWeights(), get(), surfaceArea(), surfaceIntegral(), updateToMatchGrid(), useAdaptiveMeshRefinementGrids(), volume(), and volumeIntegral().
|
protected |
Referenced by get(), initialize(), and put().
|
static |
Referenced by initialize(), and updateToMatchGrid().
|
protected |
|
protected |
Referenced by computeWeights(), initialize(), and setDeleteSolverAfterUse().
|
protected |
|
protected |
|
protected |
Referenced by computeLeftNullVector(), get(), initialize(), leftNullVector(), and put().
|
protected |
Referenced by computeLeftNullVector(), and leftNullVector().
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
Referenced by computeLeftNullVector(), computeWeights(), get(), initialize(), put(), and updateToMatchGrid().
|
protected |
|
protected |
|
protected |
Referenced by computeStitchedSurfaceWeights(), defineSurfacesAndComputeWeights(), getSurfaceStitcher(), initialize(), and ~Integrate().
|
protected |
Referenced by computeWeights(), get(), initialize(), put(), and setRadialAxis().
|
protected |
Referenced by computeLeftNullVector(), computeWeights(), initialize(), and ~Integrate().
|
protected |
|
protected |
Referenced by computeLeftNullVector(), computeWeights(), defineSurfacesAndComputeWeights(), initialize(), and setTolerance().
|
protected |
Referenced by get(), initialize(), put(), surfaceIntegral(), updateForAMR(), and useAdaptiveMeshRefinementGrids().
|
protected |
Referenced by computeSurfaceWeights(), defineSurfacesAndComputeWeights(), get(), initialize(), put(), and useHybridGrids().
|
protected |
|
protected |
|
protected |