Overture  Version 25
Public Types | Static Public Member Functions | Static Public Attributes | Static Protected Attributes | List of all members
Overture Class Reference

#include <GUIInit.h>

Collaboration diagram for Overture:
Collaboration graph
[legend]

Public Types

enum  AbortEnum { abortOnAbort, throwErrorOnAbort, abortOnAbort, throwErrorOnAbort }
 
enum  AbortEnum { abortOnAbort, throwErrorOnAbort, abortOnAbort, throwErrorOnAbort }
 

Static Public Member Functions

static int start (int argc, char *argv[])
 
static int finish ()
 
static AbortEnum getAbortOption ()
 
static void setAbortOption (AbortEnum action)
 
static void abort ()
 
static void abort (const aString &message)
 
static floatSerialArray & nullFloatArray ()
 
static doubleSerialArray & nullDoubleArray ()
 
static intSerialArray & nullIntArray ()
 
static RealArraynullRealArray ()
 
static floatDistributedArraynullFloatDistributedArray ()
 
static doubleDistributedArraynullDoubleDistributedArray ()
 
static RealDistributedArraynullRealDistributedArray ()
 
static IntegerDistributedArraynullIntegerDistributedArray ()
 
static MappingParametersnullMappingParameters ()
 
static floatMappedGridFunctionnullFloatMappedGridFunction ()
 
static doubleMappedGridFunctionnullDoubleMappedGridFunction ()
 
static realMappedGridFunctionnullRealMappedGridFunction ()
 
static intMappedGridFunctionnullIntMappedGridFunction ()
 
static
floatGridCollectionFunction
nullFloatGridCollectionFunction ()
 
static realGridCollectionFunctionnullRealGridCollectionFunction ()
 
static
doubleGridCollectionFunction
nullDoubleGridCollectionFunction ()
 
static intGridCollectionFunctionnullIntGridCollectionFunction ()
 
static
BoundaryConditionParameters
defaultBoundaryConditionParameters ()
 
static GraphicsParametersdefaultGraphicsParameters ()
 
static void setDefaultGraphicsParameters (GraphicsParameters *gp=NULL)
 
static GenericGraphicsInterfacegetGraphicsInterface (const aString &windowTitle="Your Slogan Here", const bool initialize=true, int argc=0, char *argv[]=NULL)
 
static void setGraphicsInterface (GenericGraphicsInterface *ps)
 
static ListOfMappingRCgetMappingList ()
 
static void setMappingList (ListOfMappingRC *list)
 
static int start (int &argc, char **&argv)
 
static int finish ()
 
static AbortEnum getAbortOption ()
 
static void setAbortOption (AbortEnum action)
 
static void abort ()
 
static void abort (const aString &message)
 
static real getCurrentMemoryUsage ()
 
static void turnOnMemoryChecking (bool trueOrFalse=true, real memoryUsageScaleFactor=1.1)
 turn on or off Overture's checking of the memory usage.
 
static real checkMemoryUsage (const aString &label, FILE *file=stdout)
 
static real getMaximumMemoryUsage ()
 
static real printMemoryUsage (const aString &label, FILE *file=stdout)
 
static int incrementReferenceCountForPETSc ()
 
static int decrementReferenceCountForPETSc ()
 
static floatSerialArray & nullFloatArray ()
 
static doubleSerialArray & nullDoubleArray ()
 
static RealArraynullRealArray ()
 
static intSerialArray & nullIntArray ()
 
static floatDistributedArraynullFloatDistributedArray ()
 
static doubleDistributedArraynullDoubleDistributedArray ()
 
static RealDistributedArraynullRealDistributedArray ()
 
static IntegerDistributedArraynullIntegerDistributedArray ()
 
static MappingParametersnullMappingParameters ()
 
static MappingLinkedListstaticMappingList ()
 
static floatMappedGridFunctionnullFloatMappedGridFunction ()
 
static doubleMappedGridFunctionnullDoubleMappedGridFunction ()
 
static realMappedGridFunctionnullRealMappedGridFunction ()
 
static intMappedGridFunctionnullIntMappedGridFunction ()
 
static
floatGridCollectionFunction
nullFloatGridCollectionFunction ()
 
static realGridCollectionFunctionnullRealGridCollectionFunction ()
 
static
doubleGridCollectionFunction
nullDoubleGridCollectionFunction ()
 
static intGridCollectionFunctionnullIntGridCollectionFunction ()
 
static
BoundaryConditionParameters
defaultBoundaryConditionParameters ()
 
static GraphicsParametersdefaultGraphicsParameters ()
 
static void setDefaultGraphicsParameters (GraphicsParameters *gp=NULL)
 
static GenericGraphicsInterfacegetGraphicsInterface (const aString &windowTitle="Your Slogan Here", const bool initialize=true, int argc=0, char *argv[]=NULL)
 
static void setGraphicsInterface (GenericGraphicsInterface *ps)
 
static ListOfMappingRCgetMappingList ()
 
static void setMappingList (ListOfMappingRC *list)
 
static void openDebugFile ()
 

Static Public Attributes

static FILE * debugFile =NULL
 
static void(* shutDownPETSc )() =NULL
 
static int OV_COMM =0
 

Static Protected Attributes

static GenericGraphicsInterfacepPlotStuff =NULL
 
static ListOfMappingRCpMappingList =NULL
 
static AbortEnum abortOption =Overture::abortOnAbort
 

Member Enumeration Documentation

Enumerator
abortOnAbort 
throwErrorOnAbort 
abortOnAbort 
throwErrorOnAbort 
Enumerator
abortOnAbort 
throwErrorOnAbort 
abortOnAbort 
throwErrorOnAbort 

Member Function Documentation

static void Overture::abort ( )
static
static void Overture::abort ( const aString message)
static
void Overture::abort ( )
static

Referenced by abort(), Ogen::adjustBoundary(), Ogen::adjustBoundarySerial(), HyperbolicMapping::adjustDistanceToMarch(), SlapEquationSolver::allocateWorkSpace(), MappedGridOperators::applyBCaDotGradU(), MappedGridOperators::applyBCextrapolate(), MappedGridOperators::applyBCGenDiv(), MappedGridOperators::applyBCgeneralMixedDerivative(), MappedGridOperators::applyBCneumann(), MappedGridOperators::applyBCnormalComponent(), MappedGridOperators::applyBCnormalDerivative(), MappedGridOperators::applyBCnormalDotScalarGrad(), MappedGridOperators::applyBCsymmetry(), MappedGridOperators::applyBCtangentialComponent(), UnstructuredOperators::applyBoundaryCondition(), MappedGridOperators::applyBoundaryCondition(), floatMappedGridFunction::applyBoundaryCondition(), doubleMappedGridFunction::applyBoundaryCondition(), intMappedGridFunction::applyBoundaryCondition(), MappedGridOperators::applyBoundaryConditionCoefficients(), floatMappedGridFunction::applyBoundaryConditionCoefficients(), doubleMappedGridFunction::applyBoundaryConditionCoefficients(), intMappedGridFunction::applyBoundaryConditionCoefficients(), GenericGridCollectionOperators::applyBoundaryConditions(), GenericCompositeGridOperators::applyBoundaryConditions(), HyperbolicMapping::applyBoundaryConditions(), Ogmg::applyBoundaryConditions(), Ogmg::assignBoundaryConditionCoefficients(), MappedGridOperators::assignCoefficientsInternal(), Ogmg::averageCoefficients(), ReductionMapping::basicInverse(), UserDefinedMapping1::basicInverse(), SweepMapping::basicInverse(), ReparameterizationTransform::basicInverse(), Mapping::basicInverse(), ReductionMapping::basicInverseS(), UserDefinedMapping1::basicInverseS(), ReparameterizationTransform::basicInverseS(), DataPointMapping::basicInverseS(), Mapping::basicInverseS(), TridiagonalSolver::blockFactor(), SparseArray< T >::boundsCheck(), Ogen::buildACompositeGrid(), Ogen::buildCutout(), CompositeTopology::buildEdgeCurves(), Oges::buildEquationSolvers(), Ogmg::buildExtraLevels(), Ogmg::buildExtraLevelsNew(), Ogmg::buildPredefinedCoefficientMatrix(), CanInterpolate::cgCanInterpolate(), checkGrid(), Ogen::checkInterpolationOnBoundaries(), checkParallelConsistency(), ListOfParentChildSiblingInfo::checkRange(), ListOfMappingRC::checkRange(), ListOfReferenceCountedObjects< T >::checkRange(), Ogen::classifyPoints(), Ogmg::coarseToFine(), ErrorEstimator::computeAndSmoothErrorFunction(), MappedGridOperators::computeDerivatives(), DerivedFunctions::computeDerivedFunctions(), Interpolate::computeIndexes(), Ogen::computeOverlap(), Integrate::computeStitchedSurfaceWeights(), Integrate::computeStitchedSurfaceWeightsOld(), Integrate::computeSurfaceWeights(), NurbsMapping::conic(), PlotIt::contourCuts(), CompositeGridData::convertLocalInterpolationData(), ParallelUtility::copy(), CopyArray::copyArray(), MappedGridOperators::createBoundaryMatrix(), MappingsFromCAD::createSurface(), Ogen::cutHolesNew(), Ogen::cutHolesNewer(), Ogmg::defectNorm(), BodyDefinition::defineSurface(), GridCollection::deleteGrid(), CompositeGrid::deleteGrid(), MappedGridOperators::derivativeInternal(), MappedGridOperators::derivativeScalarDerivative(), derivativeScalarDerivativeFDerivative(), derivativeScalarDerivativeFDerivative21(), derivativeScalarDerivativeFDerivative21R(), derivativeScalarDerivativeFDerivative22(), derivativeScalarDerivativeFDerivative22R(), derivativeScalarDerivativeFDerivative23(), derivativeScalarDerivativeFDerivative23R(), derivativeScalarDerivativeFDerivative42(), derivativeScalarDerivativeFDerivative43(), derivativeScalarDerivativeFDerivCoefficients(), derivativeScalarDerivativeFDerivCoefficients2(), derivativeScalarDerivativeFDerivCoefficients42(), derivativeScalarDerivativeFDerivCoefficients43(), LoadBalancer::determineLoadBalance(), LoadBalancer::determineLoadBalanceKernighanLin(), LoadBalancer::determineLoadBalanceUserDefined(), divFDerivCoefficients(), divScalarGradFDerivative(), divScalarGradFDerivative42(), divScalarGradFDerivative43(), divScalarGradFDerivCoefficients(), divScalarGradFDerivCoefficients42(), divScalarGradFDerivCoefficients43(), divVectorScalarFDerivative(), divVectorScalarFDerivative42(), divVectorScalarFDerivative43(), divVectorScalarFDerivCoefficients(), divVectorScalarFDerivCoefficients42(), divVectorScalarFDerivCoefficients43(), doubleMappedGridFunction::doubleMappedGridFunction(), SurfaceStitcher::enlargeGapWidth(), HyperbolicMapping::estimateMarchingParameters(), Ogmg::evaluateTheDefectFormula(), TridiagonalSolver::factor(), GenericMappedGridOperators::finishBoundaryConditions(), floatMappedGridFunction::finishBoundaryConditions(), doubleMappedGridFunction::finishBoundaryConditions(), intMappedGridFunction::finishBoundaryConditions(), floatMappedGridFunction::floatMappedGridFunction(), Oges::formRhsAndSolutionVectors(), OGTrigFunction::gd(), OGPolyFunction::gd(), Ogen::generateInterpolationArrays(), Oges::generateMatrix(), DistributedInverse::get(), OgmgParameters::get(), OgesParameters::get(), ShowFileReader::getAGrid(), ShowFileReader::getASolution(), SquareMapping::getBoundingBox(), BoxMapping::getBoundingBox(), ReparameterizationTransform::getBoundingBox(), Mapping::getBoundingBox(), DistributedInverse::getBoundingBoxTree(), Mapping::getBoundingBoxTree(), floatGridCollectionFunction::getComponentBase(), doubleGridCollectionFunction::getComponentBase(), intGridCollectionFunction::getComponentBase(), floatMappedGridFunction::getComponentBase(), doubleMappedGridFunction::getComponentBase(), intMappedGridFunction::getComponentBase(), floatGridCollectionFunction::getComponentBound(), doubleGridCollectionFunction::getComponentBound(), intGridCollectionFunction::getComponentBound(), floatMappedGridFunction::getComponentBound(), doubleMappedGridFunction::getComponentBound(), intMappedGridFunction::getComponentBound(), floatGridCollectionFunction::getComponentDimension(), doubleGridCollectionFunction::getComponentDimension(), intGridCollectionFunction::getComponentDimension(), floatMappedGridFunction::getComponentDimension(), doubleMappedGridFunction::getComponentDimension(), intMappedGridFunction::getComponentDimension(), floatCompositeGridFunction::getCompositeGrid(), doubleCompositeGridFunction::getCompositeGrid(), intCompositeGridFunction::getCompositeGrid(), floatGridCollectionFunction::getCoordinateBase(), doubleGridCollectionFunction::getCoordinateBase(), intGridCollectionFunction::getCoordinateBase(), floatMappedGridFunction::getCoordinateBase(), doubleMappedGridFunction::getCoordinateBase(), intMappedGridFunction::getCoordinateBase(), floatGridCollectionFunction::getCoordinateBound(), doubleGridCollectionFunction::getCoordinateBound(), intGridCollectionFunction::getCoordinateBound(), floatMappedGridFunction::getCoordinateBound(), doubleMappedGridFunction::getCoordinateBound(), intMappedGridFunction::getCoordinateBound(), floatGridCollectionFunction::getCoordinateDimension(), doubleGridCollectionFunction::getCoordinateDimension(), intGridCollectionFunction::getCoordinateDimension(), floatMappedGridFunction::getCoordinateDimension(), doubleMappedGridFunction::getCoordinateDimension(), intMappedGridFunction::getCoordinateDimension(), OGFunction::getCoordinates(), BoundaryConditionParameters::getCornerBoundaryCondition(), HDF_DataBase::getDistributed(), floatGridCollectionFunction::getFaceCentering(), doubleGridCollectionFunction::getFaceCentering(), intGridCollectionFunction::getFaceCentering(), MappedGridOperators::getFourierOperators(), ShowFileReader::getFrame(), Ogmg::getGhostLineBoundaryCondition(), Mapping::getGrid(), floatGridCollectionFunction::getGridCollection(), doubleGridCollectionFunction::getGridCollection(), intGridCollectionFunction::getGridCollection(), Mapping::getIndex(), floatCompositeGridFunction::getInterpolant(), doubleCompositeGridFunction::getInterpolant(), intCompositeGridFunction::getInterpolant(), GenericCompositeGridOperators::getInterpolationCoefficients(), ExposedPoints::getInterpolationStencil(), Ogmg::getInterpolationStencil(), Mapping::getIsPeriodic(), SplineMapping::getKnots(), floatMappedGridFunction::getMappedGrid(), doubleMappedGridFunction::getMappedGrid(), intMappedGridFunction::getMappedGrid(), floatGridCollectionFunction::getNumberOfComponents(), doubleGridCollectionFunction::getNumberOfComponents(), intGridCollectionFunction::getNumberOfComponents(), ExposedPoints::getNumberOfExposedPoints(), ShowFileReader::getNumberOfFrames(), ShowFileReader::getNumberOfSequences(), ShowFileReader::getNumberOfSolutions(), Mapping::getParameter(), SplineMapping::getParameterization(), MappedGrid::getRectangularGridParameters(), getTimeStep(), BoundaryConditionParameters::getVariableCoefficients(), MappedGridOperators::getVelocityComponents(), gradFDerivCoefficients(), HyperbolicMapping::implicitSolve(), ExposedPoints::initialize(), floatGridCollectionFunction::initialize(), doubleGridCollectionFunction::initialize(), intGridCollectionFunction::initialize(), Ogmg::initializeConstantCoefficients(), ParallelOverlappingGridInterpolator::internalInterpolate(), InterpolatePointsOnAGrid::internalInterpolate(), ParallelOverlappingGridInterpolator::interpolate(), Interpolant::interpolate(), NurbsMapping::interpolate(), InterpolatePoints::interpolateAllPoints(), interpolateAllPoints(), InterpolateRefinements::interpolateCoarseFromFine(), Interpolate::interpolateCoarseFromFine(), Interpolate::interpolateCoarseToFine(), interpolateExposedPoints(), Interpolate::interpolateFineFromCoarse(), Interpolate::interpolateFineToCoarse(), InterpolatePoints::interpolatePoints(), interpolatePoints(), InterpolatePointsOnAGrid::interpolatePoints(), ExposedPoints::interpolatePoints(), InterpolateRefinements::interpolateRefinementBoundaries(), Interpolant::interpolateRefinementLevel(), InterpolateRefinements::interpolateRefinements(), interpolateRefinements(), NurbsMapping::interpolateVolume(), Mapping::intersects(), intMappedGridFunction::intMappedGridFunction(), ReparameterizationTransform::inverseMap(), Mapping::inverseMapGrid(), Mapping::inverseMapGridS(), ReparameterizationTransform::inverseMapS(), TridiagonalSolver::invert(), laplaceFDerivCoefficients(), EllipticGridGenerator::lineSmoother(), floatCompositeGridFunction::link(), doubleCompositeGridFunction::link(), intCompositeGridFunction::link(), main(), LoftedSurfaceMapping::map(), ReductionMapping::map(), UserDefinedMapping1::map(), SweepMapping::map(), ReparameterizationTransform::map(), DataPointMapping::map(), SplineMapping::map(), TrimmedMapping::map(), Mapping::map(), Mapping::mapGrid(), Mapping::mapGridS(), UserDefinedMapping1::mapS(), ReparameterizationTransform::mapS(), StretchMapping::mapS(), NurbsMapping::mapS(), DataPointMapping::mapScalar(), Ogen::markPointsNeededForInterpolationNew(), TridiagonalSolver::matrixVectorMultiply(), HDF_DataBase::mount(), Ogen::movingUpdateNew(), TridiagonalSolver::multiply(), multiply(), OGcheckIndex(), ShowFileReader::open(), HDF_DataBase::openLocalFile(), floatMappedGridFunction::operator()(), doubleMappedGridFunction::operator()(), intMappedGridFunction::operator()(), GridCollectionOperators::operator=(), CompositeGridOperators::operator=(), MappedGridOperators::operator=(), floatGridCollectionFunction::operator=(), doubleGridCollectionFunction::operator=(), intGridCollectionFunction::operator=(), floatMappedGridFunction::operator=(), doubleMappedGridFunction::operator=(), intMappedGridFunction::operator=(), GridCollectionOperators::operator[](), CompositeGridOperators::operator[](), GenericGridCollectionOperators::operator[](), GenericCompositeGridOperators::operator[](), Ogmg::operatorAveraging(), InterpolatePointsOnAGrid::parallelInternalInterpolate(), TridiagonalSolver::periodicTridiagonalFactor(), TridiagonalSolver::periodicTridiagonalSolve(), PlotIt::plotGrid(), PlotIt::plotGridQuality(), Mapping::project(), DistributedInverse::put(), CurveSegment::put(), HDF_DataBase::put(), Ogen::queryAPoint(), rDerivative(), rDerivCoefficients(), doubleCompositeGridFunction::reference(), intCompositeGridFunction::reference(), floatCompositeGridFunction::reference(), Regrid::regridRotated(), GridCollectionData::replaceRefinementLevels(), rrDerivative(), rrDerivCoefficients(), rsDerivative(), rsDerivCoefficients(), rtDerivative(), rtDerivCoefficients(), rungeKutta2(), MappedGridOperators::scalarCoefficients(), scalarGradFDerivative(), scalarGradFDerivative42(), scalarGradFDerivative43(), scalarGradFDerivCoefficients(), sDerivative(), sDerivCoefficients(), OgmgParameters::set(), Ogmg::setBoundaryConditions(), Oges::setCoefficientArray(), OGPolyFunction::setCoefficients(), BoundaryConditionParameters::setCornerBoundaryCondition(), GenericMappedGridOperators::setCornerCoefficients(), DataPointMapping::setDataPoints(), MappedGridOperators::setDerivativeType(), Oges::setEquationAndBoundaryConditions(), EquationSolver::setExtraEquationValues(), GenericMappedGridOperators::setExtrapolationCoefficients(), floatMappedGridFunction::setFaceCentering(), doubleMappedGridFunction::setFaceCentering(), intMappedGridFunction::setFaceCentering(), Oges::setFillinRatio(), Oges::setFillinRatio2(), Mapping::setGridDimensions(), Oges::setHarwellTolerance(), floatCompositeGridFunction::setIsACoefficientMatrix(), doubleCompositeGridFunction::setIsACoefficientMatrix(), intCompositeGridFunction::setIsACoefficientMatrix(), floatGridCollectionFunction::setIsACoefficientMatrix(), doubleGridCollectionFunction::setIsACoefficientMatrix(), intGridCollectionFunction::setIsACoefficientMatrix(), Oges::setIterativeImprovement(), Oges::setMatrixCutoff(), Oges::setNullVectorScaling(), intCompositeGridFunction::setOperators(), floatCompositeGridFunction::setOperators(), doubleCompositeGridFunction::setOperators(), floatGridCollectionFunction::setOperators(), doubleGridCollectionFunction::setOperators(), intGridCollectionFunction::setOperators(), Mapping::setParameter(), GenericMappedGridOperators::setPeriodicCoefficients(), Oges::setSorNumberOfIterations(), Oges::setSorOmega(), Oges::setSorTolerance(), ParallelOverlappingGridInterpolator::setup(), Oges::setZeroRatio(), Ogmg::smooth(), ErrorEstimator::smoothErrorFunction(), Ogmg::smoothLine(), TridiagonalSolver::solve(), Oges::solve(), ssDerivative(), ssDerivCoefficients(), stDerivative(), stDerivCoefficients(), PlotIt::streamLines3d(), tDerivative(), tDerivCoefficients(), testConsistency(), CanInterpolate::transferInterpDataForAMR(), TridiagonalSolver::tridiagonalFactor(), TridiagonalSolver::tridiagonalSolve(), ttDerivative(), ttDerivCoefficients(), Ogen::updateBoundaryAdjustment(), HyperbolicMapping::updateLinesAndDistanceToMarch(), HyperbolicMapping::updateMarchingParameters(), Ogen::updateRefinement(), Ogen::updateRefinementFillInterpolationData(), Ogen::updateRefinementFillInterpolationDataNew(), Ogen::updateRefinementNew(), Ogen::updateRefinementNewer(), MappedGridOperators::updateToMatchGrid(), intCompositeGridFunction::updateToMatchGrid(), doubleCompositeGridFunction::updateToMatchGrid(), floatCompositeGridFunction::updateToMatchGrid(), intGridCollectionFunction::updateToMatchGrid(), doubleGridCollectionFunction::updateToMatchGrid(), floatGridCollectionFunction::updateToMatchGrid(), floatMappedGridFunction::updateToMatchGrid(), doubleMappedGridFunction::updateToMatchGrid(), intMappedGridFunction::updateToMatchGrid(), doubleCompositeGridFunction::updateToMatchGridFunction(), intCompositeGridFunction::updateToMatchGridFunction(), floatCompositeGridFunction::updateToMatchGridFunction(), doubleCompositeGridFunction::updateToMatchNumberOfGrids(), intCompositeGridFunction::updateToMatchNumberOfGrids(), floatCompositeGridFunction::updateToMatchNumberOfGrids(), Oges::writePetscMatrixToFile(), xFDerivative(), xFDerivative22(), xFDerivative23(), xFDerivative42(), xFDerivative43(), xFDerivCoefficients(), MappedGridOperators::xi(), xxFDerivative(), xxFDerivative22(), xxFDerivative23(), xxFDerivative42(), xxFDerivative43(), xxFDerivCoefficients(), xyFDerivative(), xyFDerivative22(), xyFDerivative23(), xyFDerivative42(), xyFDerivative43(), xyFDerivCoefficients(), xzFDerivative(), xzFDerivative22(), xzFDerivative23(), xzFDerivative42(), xzFDerivative43(), xzFDerivCoefficients(), yFDerivative(), yFDerivative22(), yFDerivative23(), yFDerivative42(), yFDerivative43(), yFDerivCoefficients(), yyFDerivative(), yyFDerivative22(), yyFDerivative23(), yyFDerivative42(), yyFDerivative43(), yyFDerivCoefficients(), yzFDerivative(), yzFDerivative22(), yzFDerivative23(), yzFDerivative42(), yzFDerivative43(), yzFDerivCoefficients(), zFDerivative(), zFDerivative22(), zFDerivative23(), zFDerivative42(), zFDerivative43(), zFDerivCoefficients(), zzFDerivative(), zzFDerivative22(), zzFDerivative23(), zzFDerivative42(), zzFDerivative43(), and zzFDerivCoefficients().

void Overture::abort ( const aString message)
static

References abort(), abortOnAbort, and abortOption.

real Overture::checkMemoryUsage ( const aString label,
FILE *  file = stdout 
)
static
int Overture::decrementReferenceCountForPETSc ( )
static
static BoundaryConditionParameters& Overture::defaultBoundaryConditionParameters ( )
static
BoundaryConditionParameters & Overture::defaultBoundaryConditionParameters ( )
static
static GraphicsParameters& Overture::defaultGraphicsParameters ( )
static
GraphicsParameters & Overture::defaultGraphicsParameters ( )
static
static int Overture::finish ( )
static
int Overture::finish ( )
static
static AbortEnum Overture::getAbortOption ( )
static
Overture::AbortEnum Overture::getAbortOption ( )
static

References abortOption.

real Overture::getCurrentMemoryUsage ( )
static
static GenericGraphicsInterface* Overture::getGraphicsInterface ( const aString windowTitle = "Your Slogan Here",
const bool  initialize = true,
int  argc = 0,
char *  argv[] = NULL 
)
static
GenericGraphicsInterface * Overture::getGraphicsInterface ( const aString windowTitle = "Your Slogan Here",
const bool  initialize = true,
int  argc = 0,
char *  argv[] = NULL 
)
static
static ListOfMappingRC* Overture::getMappingList ( )
static
ListOfMappingRC * Overture::getMappingList ( )
static

References pMappingList.

real Overture::getMaximumMemoryUsage ( )
static

Referenced by Ogen::computeOverlap(), and main().

int Overture::incrementReferenceCountForPETSc ( )
static
doubleSerialArray & Overture::nullDoubleArray ( )
static

References NULL.

static doubleSerialArray& Overture::nullDoubleArray ( )
static
static doubleDistributedArray& Overture::nullDoubleDistributedArray ( )
static
doubleDistributedArray & Overture::nullDoubleDistributedArray ( )
static

References NULL.

static doubleGridCollectionFunction& Overture::nullDoubleGridCollectionFunction ( )
static
doubleGridCollectionFunction & Overture::nullDoubleGridCollectionFunction ( )
static

References NULL.

static doubleMappedGridFunction& Overture::nullDoubleMappedGridFunction ( )
static
doubleMappedGridFunction & Overture::nullDoubleMappedGridFunction ( )
static

References NULL.

floatSerialArray & Overture::nullFloatArray ( )
static

References NULL.

static floatSerialArray& Overture::nullFloatArray ( )
static
static floatDistributedArray& Overture::nullFloatDistributedArray ( )
static
floatDistributedArray & Overture::nullFloatDistributedArray ( )
static

References NULL.

static floatGridCollectionFunction& Overture::nullFloatGridCollectionFunction ( )
static
floatGridCollectionFunction & Overture::nullFloatGridCollectionFunction ( )
static

References NULL.

static floatMappedGridFunction& Overture::nullFloatMappedGridFunction ( )
static
floatMappedGridFunction & Overture::nullFloatMappedGridFunction ( )
static

References NULL.

intSerialArray & Overture::nullIntArray ( )
static
static intSerialArray& Overture::nullIntArray ( )
static
static IntegerDistributedArray& Overture::nullIntegerDistributedArray ( )
static
IntegerDistributedArray & Overture::nullIntegerDistributedArray ( )
static
static intGridCollectionFunction& Overture::nullIntGridCollectionFunction ( )
static
intGridCollectionFunction & Overture::nullIntGridCollectionFunction ( )
static

References NULL.

static intMappedGridFunction& Overture::nullIntMappedGridFunction ( )
static
intMappedGridFunction & Overture::nullIntMappedGridFunction ( )
static

References NULL.

static MappingParameters& Overture::nullMappingParameters ( )
static
MappingParameters & Overture::nullMappingParameters ( )
static

References NULL.

static RealArray& Overture::nullRealArray ( )
static
RealArray & Overture::nullRealArray ( )
static
static RealDistributedArray& Overture::nullRealDistributedArray ( )
static
RealDistributedArray & Overture::nullRealDistributedArray ( )
static
static realGridCollectionFunction& Overture::nullRealGridCollectionFunction ( )
static
realGridCollectionFunction & Overture::nullRealGridCollectionFunction ( )
static

References NULL, and realGridCollectionFunction.

static realMappedGridFunction& Overture::nullRealMappedGridFunction ( )
static
realMappedGridFunction & Overture::nullRealMappedGridFunction ( )
static
void Overture::openDebugFile ( )
static
real Overture::printMemoryUsage ( const aString label,
FILE *  file = stdout 
)
static
static void Overture::setAbortOption ( AbortEnum  action)
static
void Overture::setAbortOption ( AbortEnum  action)
static

References abortOption.

static void Overture::setDefaultGraphicsParameters ( GraphicsParameters gp = NULL)
static
void Overture::setDefaultGraphicsParameters ( GraphicsParameters gp = NULL)
static

References NULL.

static void Overture::setGraphicsInterface ( GenericGraphicsInterface ps)
static
void Overture::setGraphicsInterface ( GenericGraphicsInterface ps)
static
static void Overture::setMappingList ( ListOfMappingRC list)
static
void Overture::setMappingList ( ListOfMappingRC list)
static

References pMappingList.

int Overture::start ( int &  argc,
char **&  argv 
)
static
static int Overture::start ( int  argc,
char *  argv[] 
)
static

Referenced by main().

MappingLinkedList & Overture::staticMappingList ( )
static

References NULL.

Referenced by Mapping::staticMapList().

void Overture::turnOnMemoryChecking ( bool  trueOrFalse = true,
real  memUsageScaleFactor = 1.1 
)
static

turn on or off Overture's checking of the memory usage.

Parameters
trueOrFalse(input) : if true then print messages (from checkMemoryUsage) when the memory has increased by a factor of memUsageScaleFactor from the previous maximum usage.
memUsageScaleFactor(input) : indicates how often to print messages.

Referenced by main(), and plotStuff().

Member Data Documentation

Overture::AbortEnum Overture::abortOption =Overture::abortOnAbort
staticprotected
FILE * Overture::debugFile =NULL
static
int Overture::OV_COMM =0
static
ListOfMappingRC * Overture::pMappingList =NULL
staticprotected

Referenced by getMappingList(), and setMappingList().

GenericGraphicsInterface * Overture::pPlotStuff =NULL
staticprotected
shutDownPETScFunctionPointer Overture::shutDownPETSc =NULL
static

The documentation for this class was generated from the following files: