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

#include <Oges.h>

Collaboration diagram for Oges:
Collaboration graph
[legend]

Public Types

enum  SparseStorageFormatEnum { uncompressed, compressedRow, other }
 
enum  EquationSolverEnum { maximumNumberOfEquationSolvers =10 }
 
enum  coefficientTypes { continuous =0, discrete =1 }
 
enum  solvers {
  yale =1, harwell =2, bcg =3, sor =4,
  SLAP, PETSc
}
 
enum  conjugateGradientTypes { biConjugateGradient =0, biConjugateGradientSquared =1, GMRes =2, CGStab =3 }
 
enum  conjugateGradientPreconditioners { none =0, diagonal =1, incompleteLU =2, SSOR =3 }
 

Public Member Functions

 Oges ()
 
 Oges (CompositeGrid &cg)
 
 Oges (MappedGrid &mg)
 
 Oges (const Oges &X)
 
Ogesoperator= (const Oges &x)
 
virtual ~Oges ()
 
int setEquationAndBoundaryConditions (OgesParameters::EquationEnum equation, CompositeGridOperators &op, const IntegerArray &boundaryConditions, const RealArray &bcData, RealArray &constantCoeff=Overture::nullRealArray(), realCompositeGridFunction *variableCoeff=NULL)
 !Define a predefined equation ** this is new ****
 
int setCoefficientsAndBoundaryConditions (realCompositeGridFunction &coeff, const IntegerArray &boundaryConditions, const RealArray &bcData)
 Supply matrix coefficients and boundary conditions (new way).
 
void determineErrors (realCompositeGridFunction &u, OGFunction &exactSolution, int &printOptions)
 
aString getErrorMessage (const int errorNumber)
 
int get (OgesParameters::OptionEnum option, int &value) const
 
int get (OgesParameters::OptionEnum option, real &value) const
 
int getCompatibilityConstraint () const
 
int getNumberOfIterations ()
 
real getMaximumResidual () const
 
int initialize ()
 
bool isSolverIterative () const
 
bool canSolveInPlace () const
 
int getMatrix (IntegerArray &ia, IntegerArray &ja, RealArray &a, SparseStorageFormatEnum format=compressedRow)
 
int matrixVectorMultiply (int n, real *x, real *y)
 
int computeResidual (int n, real *x, real *b, real *r)
 
int assignVector (int n, real *x, realCompositeGridFunction &u)
 
int storeVector (int n, real *x, realCompositeGridFunction &u)
 
int printStatistics (FILE *file=stdout) const
 
int set (OgesParameters::SolverEnum option)
 
int set (OgesParameters::SolverMethodEnum option)
 
int set (OgesParameters::MatrixOrderingEnum option)
 
int set (OgesParameters::PreconditionerEnum option)
 
int set (OgesParameters::OptionEnum option, int value=0)
 
int set (OgesParameters::OptionEnum option, float value)
 
int set (OgesParameters::OptionEnum option, double value)
 
int setOgesParameters (const OgesParameters &opar)
 
int setExtraEquationValues (realCompositeGridFunction &f, real *value)
 
int getExtraEquationValues (const realCompositeGridFunction &u, real *value)
 
int evaluateExtraEquation (const realCompositeGridFunction &u, real &value, int extraEquation=0)
 
int evaluateExtraEquation (const realCompositeGridFunction &u, real &value, real &sumOfExtraEquationCoefficients, int extraEquation=0)
 
virtual real sizeOf (FILE *file=NULL) const
 
virtual int get (const GenericDataBase &dir, const aString &name)
 
virtual int put (GenericDataBase &dir, const aString &name) const
 
int outputSparseMatrix (const aString &fileName)
 
int writeMatrixToFile (aString fileName)
 
int writeMatrixGridInformationToFile (aString fileName)
 
int writePetscMatrixToFile (aString filename, realCompositeGridFunction &u, realCompositeGridFunction &f)
 
void reference (const Oges &)
 
int setCoefficientArray (realCompositeGridFunction &coeff, const IntegerArray &boundaryConditions=Overture::nullIntArray(), const RealArray &bcData=Overture::nullRealArray())
 
int setCoefficientArray (realMappedGridFunction &coeff, const IntegerArray &boundaryConditions=Overture::nullIntArray(), const RealArray &bcData=Overture::nullRealArray())
 
int setGridsToUse (const IntegerArray &gridsToUse)
 
bool activeGrid (int grid) const
 
const IntegerArraygetUseThisGrid () const
 
int setCommandLineArguments (int argc, char **argv)
 
void setGrid (CompositeGrid &cg, bool outOfDate=true)
 
void setGrid (MappedGrid &mg, bool outOfDate=true)
 
void set (MultigridCompositeGrid &mgcg)
 Supply a MultigridCompositeGrid (for use with the multigrid solver Ogmg).
 
void setGridName (const aString &name)
 
void setSolverName (const aString &name)
 
int solve (realCompositeGridFunction &u, realCompositeGridFunction &f)
 
int solve (realMappedGridFunction &u, realMappedGridFunction &f)
 
int updateToMatchGrid (CompositeGrid &cg)
 
int updateToMatchGrid (MappedGrid &mg)
 
int update (GenericGraphicsInterface &gi, CompositeGrid &cg)
 
int buildEquationSolvers (OgesParameters::SolverEnum solver)
 
int formMatrix (int &numberOfEquations, int &numberOfNonzeros, SparseStorageFormatEnum storageFormat, bool allocateSpace=TRUE, bool factorMatrixInPlace=FALSE)
 
int formRhsAndSolutionVectors (realCompositeGridFunction &u, realCompositeGridFunction &f)
 
int storeSolutionIntoGridFunction ()
 
void equationToIndex (const int eqnNo0, int &n, int &i1, int &i2, int &i3, int &grid)
 
int printObsoleteMessage (const aString &routineName, int option=0)
 
void setCompositeGrid (CompositeGrid &cg)
 
void setConjugateGradientType (const conjugateGradientTypes conjugateGradientType)
 
void setConjugateGradientPreconditioner (const conjugateGradientPreconditioners conjugateGradientPreconditioner)
 
void setConjugateGradientNumberOfIterations (const int conjugateGradientNumberOfIterations)
 
void setConjugateGradientNumberOfSaveVectors (const int conjugateGradientNumberOfSaveVectors)
 
void setConjugateGradientTolerance (const real conjugateGradientTolerance)
 
void setCompatibilityConstraint (const bool trueOrFalse)
 
void setEvaluateJacobian (const int EvaluateJacobian)
 
void setFillinRatio (const real fillinRatio)
 
void setFillinRatio2 (const real fillinRatio2)
 
void setFixupRightHandSide (const bool trueOrFalse)
 
void setHarwellTolerance (const real harwellTolerance)
 
void setIterativeImprovement (const int trueOrFalse)
 
void setNumberOfComponents (const int numberOfComponents)
 
void setNullVectorScaling (const real &scale)
 
void setMatrixCutoff (const real matrixCutoff)
 
void setOrderOfAccuracy (const int order)
 
void setPreconditionBoundary (const int preconditionBoundary)
 
void setPreconditionRightHandSide (const int preconditionRightHandSide)
 
void setRefactor (const int refactor)
 
void setReorder (const int reorder)
 
void setSolverJob (const int solverJob)
 
void setSolverType (const solvers solverType)
 
void setSorNumberOfIterations (const int sorNumberOfIterations)
 
void setSorTolerance (const real sorTolerance)
 
void setSorOmega (const real sorOmega)
 
void setTranspose (const int transpose)
 
void setZeroRatio (const real zeroRatio)
 
void setCoefficientType (const coefficientTypes coefficientType)
 

Public Attributes

enum Oges::SparseStorageFormatEnum sparseStorageFormat
 
int ndia
 
int ndja
 
int nda
 
RealArray sol
 
RealArray rhs
 
IntegerArray ia
 
IntegerArray ja
 
RealArray a
 
CompositeGrid cg
 
OgesParameters parameters
 
MultigridCompositeGrid mgcg
 
realCompositeGridFunction coeff
 
intArray * classify
 
realCompositeGridFunction uLinearized
 
ListOfRealSerialArray ul
 
ListOfRealSerialArray fl
 
int numberOfExtraEquations
 
IntegerArray extraEquationNumber
 
realCompositeGridFunctioncoefficientsOfDenseExtraEquations
 
realCompositeGridFunction rightNullVector
 
int solvingSparseSubset
 
int solverJob
 
int initialized
 
bool shouldBeInitialized
 
int numberOfGrids
 
int numberOfDimensions
 
int numberOfComponents
 
int stencilSize
 
int refactor
 
int reorder
 
int evaluateJacobian
 
bool recomputePreconditioner
 
int numberOfEquations
 
int numberOfNonzerosBound
 
int numberOfNonzeros
 
int preconditionBoundary
 
int preconditionRightHandSide
 
int numberOfIterations
 
aString gridName
 
aString solverName
 
int argc
 
char ** argv
 
EquationSolverequationSolver [maximumNumberOfEquationSolvers]
 
coefficientTypes coefficientType
 
real actualZeroRatio
 
real actualFillinRatio
 
real actualFillinRatio2
 
real maximumResidual
 

Static Public Attributes

static int debug =0
 

Protected Member Functions

void setup ()
 
void findExtraEquations ()
 
void makeRightNullVector ()
 
void generateMatrixError (const int nda, const int ieqn)
 
void generateMatrix (int &errorNumber)
 
void privateUpdateToMatchGrid ()
 
int arraySize (const int grid, const int axis)
 
int arrayDims (const int grid, const int side, const int axis)
 
int equationNo (const int n, const int i1, const int i2, const int i3, const int grid)
 
IntegerDistributedArray equationNo (const int n, const Index &I1, const Index &I2, const Index &I3, const int grid)
 

Protected Attributes

OgesParameters::EquationEnum equationToSolve
 
RealArray constantCoefficients
 
IntegerArray boundaryConditions
 
RealArray bcData
 
IntegerArray gridEquationBase
 
bool useAllGrids
 
IntegerArray useThisGrid
 

Member Enumeration Documentation

Enumerator
continuous 
discrete 
Enumerator
none 
diagonal 
incompleteLU 
SSOR 
Enumerator
biConjugateGradient 
biConjugateGradientSquared 
GMRes 
CGStab 
Enumerator
maximumNumberOfEquationSolvers 
Enumerator
yale 
harwell 
bcg 
sor 
SLAP 
PETSc 
Enumerator
uncompressed 
compressedRow 
other 

Constructor & Destructor Documentation

Oges::Oges ( )

References setup().

Oges::Oges ( CompositeGrid cg)
Oges::Oges ( MappedGrid mg)
Oges::Oges ( const Oges X)

References setup().

Oges::~Oges ( )
virtual

Member Function Documentation

bool Oges::activeGrid ( int  grid) const
int Oges::arrayDims ( const int  grid,
const int  side,
const int  axis 
)
inlineprotected

References cg.

Referenced by equationToIndex(), and generateMatrix().

int Oges::arraySize ( const int  grid,
const int  axis 
)
inlineprotected

References cg, End, and Start.

Referenced by equationToIndex(), formMatrix(), generateMatrix(), and initialize().

int Oges::assignVector ( int  n,
real x,
realCompositeGridFunction u 
)
int Oges::buildEquationSolvers ( OgesParameters::SolverEnum  solver)
bool Oges::canSolveInPlace ( ) const
int Oges::computeResidual ( int  n,
real x,
real b,
real r 
)
void Oges::determineErrors ( realCompositeGridFunction u,
OGFunction exactSolution,
int &  printOptions 
)
int Oges::equationNo ( const int  n,
const int  i1,
const int  i2,
const int  i3,
const int  grid 
)
inlineprotected
IntegerDistributedArray Oges::equationNo ( const int  n,
const Index &  I1,
const Index &  I2,
const Index &  I3,
const int  grid 
)
protected

References equationNo(), and i2.

void Oges::equationToIndex ( const int  eqnNo0,
int &  n,
int &  i1,
int &  i2,
int &  i3,
int &  grid 
)
int Oges::evaluateExtraEquation ( const realCompositeGridFunction u,
real value,
int  extraEquation = 0 
)
int Oges::evaluateExtraEquation ( const realCompositeGridFunction u,
real value,
real sumOfExtraEquationCoefficients,
int  extraEquation = 0 
)
void Oges::findExtraEquations ( )
protected
int Oges::formMatrix ( int &  numberOfEquations,
int &  numberOfNonzeros,
SparseStorageFormatEnum  storageFormat,
bool  allocateSpace = TRUE,
bool  factorMatrixInPlace = FALSE 
)
int Oges::formRhsAndSolutionVectors ( realCompositeGridFunction u,
realCompositeGridFunction f 
)
void Oges::generateMatrix ( int &  errorNumber)
protected
void Oges::generateMatrixError ( const int  nda,
const int  ieqn 
)
protected
int Oges::get ( OgesParameters::OptionEnum  option,
int &  value 
) const
int Oges::get ( OgesParameters::OptionEnum  option,
real value 
) const
int Oges::get ( const GenericDataBase dir,
const aString name 
)
virtual
int Oges::getCompatibilityConstraint ( ) const
aString Oges::getErrorMessage ( const int  errorNumber)

References CGESER.

int Oges::getExtraEquationValues ( const realCompositeGridFunction u,
real value 
)
int Oges::getMatrix ( IntegerArray ia,
IntegerArray ja,
RealArray a,
SparseStorageFormatEnum  format = compressedRow 
)
real Oges::getMaximumResidual ( ) const
int Oges::getNumberOfIterations ( )
const IntegerArray & Oges::getUseThisGrid ( ) const

References useThisGrid.

int Oges::initialize ( )
bool Oges::isSolverIterative ( ) const
void Oges::makeRightNullVector ( )
protected
int Oges::matrixVectorMultiply ( int  n,
real x,
real y 
)
Oges & Oges::operator= ( const Oges x)
int Oges::outputSparseMatrix ( const aString fileName)
int Oges::printObsoleteMessage ( const aString routineName,
int  option = 0 
)
int Oges::printStatistics ( FILE *  file = stdout) const

References NULL.

void Oges::privateUpdateToMatchGrid ( )
protected
int Oges::put ( GenericDataBase dir,
const aString name 
) const
virtual
void Oges::reference ( const Oges )
int Oges::set ( OgesParameters::SolverEnum  option)
int Oges::set ( OgesParameters::SolverMethodEnum  option)
int Oges::set ( OgesParameters::MatrixOrderingEnum  option)
int Oges::set ( OgesParameters::PreconditionerEnum  option)
int Oges::set ( OgesParameters::OptionEnum  option,
int  value = 0 
)
int Oges::set ( OgesParameters::OptionEnum  option,
float  value 
)
int Oges::set ( OgesParameters::OptionEnum  option,
double  value 
)
void Oges::set ( MultigridCompositeGrid mgcg_)

Supply a MultigridCompositeGrid (for use with the multigrid solver Ogmg).

Parameters
mgcg(input) : use this object to hold the multigrid hierarchy.

The MultigridCompositeGrid object can be used to share a multigrid hierarchy amongst different applications and means that the coarse grid levels need only be generated once.

References mgcg, and MultigridCompositeGrid::reference().

int Oges::setCoefficientArray ( realCompositeGridFunction coeff,
const IntegerArray boundaryConditions = Overture::nullIntArray(),
const RealArray bcData = Overture::nullRealArray() 
)
int Oges::setCoefficientArray ( realMappedGridFunction coeff,
const IntegerArray boundaryConditions = Overture::nullIntArray(),
const RealArray bcData = Overture::nullRealArray() 
)
int Oges::setCoefficientsAndBoundaryConditions ( realCompositeGridFunction coeff0,
const IntegerArray boundaryConditions,
const RealArray bcData 
)

Supply matrix coefficients and boundary conditions (new way).

This function should be used in the following fashion:

  • call oges.setGrid(cg) to define a new grid. When using multigrid this will build the multigrid levels.
  • call this function to define the coefficients and boundary conditions. Do NOT call oges.updateToMatchGrid(cg)
  • call oges.solve(u,f) to solve the equations. If the equations change but not the grid, call this function again with the new coefficients. If the grid has changed then call both oges.setGrid() and this function again.
Parameters
coeff0(input): Here are the coefficients. Oges will keep a reference to this grid function.
boundaryConditions(0:1,0:2,numberOfComponentGrids)(input) : optionally supply boundary conditions. These are currently needed by the multigrid solver.
bcData: data for the boundary conditions.

References buildEquationSolvers(), equationSolver, initialize(), OgesParameters::multigrid, NULL, parameters, setCoefficientArray(), EquationSolver::setCoefficientsAndBoundaryConditions(), OgesParameters::solver, and solverJob.

void Oges::setCoefficientType ( const coefficientTypes  coefficientType)

References coefficientType.

int Oges::setCommandLineArguments ( int  argc,
char **  argv 
)

References argc, and argv.

void Oges::setCompatibilityConstraint ( const bool  trueOrFalse)
void Oges::setCompositeGrid ( CompositeGrid cg)
void Oges::setConjugateGradientNumberOfIterations ( const int  conjugateGradientNumberOfIterations)
void Oges::setConjugateGradientNumberOfSaveVectors ( const int  conjugateGradientNumberOfSaveVectors)
void Oges::setConjugateGradientPreconditioner ( const conjugateGradientPreconditioners  conjugateGradientPreconditioner)
void Oges::setConjugateGradientTolerance ( const real  conjugateGradientTolerance)
void Oges::setConjugateGradientType ( const conjugateGradientTypes  conjugateGradientType)
int Oges::setEquationAndBoundaryConditions ( OgesParameters::EquationEnum  equation,
CompositeGridOperators op,
const IntegerArray boundaryConditions_,
const RealArray bcData_,
RealArray constantCoeff = Overture::nullRealArray(),
realCompositeGridFunction varCoeff = NULL 
)

!Define a predefined equation ** this is new ****

Parameters
equation: defines the equation. If you are supplying a coefficient matrix as a grid function then equation==userDefined. If you want to solve a predefined equation choose equation==laplaceEquation or ...
boundaryConditions(side,axis,grid): defines boundary conditions as dirichlet, neumann, mixed, dirichletAndEvenSymmetry, dirichletAndOddSymmetry, extrapolate (defined by the BoundaryConditionEnum).
bcData(0:*,side,axis,grid): for a mixed boundary condition a(0)=bcData(0,side,axis,grid). For extrapolation, orderOfExtrapolation=bcData(0,side,axis,grid) where 0 means use the default of orderOfExtrapolation=orderOfAccuracy+1

References BoundaryConditionParameters::a, Overture::abort(), doubleCompositeGridFunction::applyBoundaryConditionCoefficients(), assert, axis2, OgesParameters::axisymmetric, bcData, BCTypes::boundary1, boundaryConditions, buildEquationSolvers(), c, cg, coeff, constantCoefficients, debug, MappedGrid::dimension(), BCTypes::dirichlet, OgesParameters::dirichlet, OgesParameters::dirichletAndEvenSymmetry, OgesParameters::dirichletAndOddSymmetry, MappedGridOperators::divergenceScalarGradient, OgesParameters::divScalarGradHeatEquationOperator, OgesParameters::divScalarGradOperator, dx, equationSolver, equationToSolve, BCTypes::evenSymmetry, BCTypes::extrapolate, OgesParameters::extrapolate, doubleCompositeGridFunction::finishBoundaryConditions(), ForBoundary, getBoundaryIndex(), getIndex(), ParallelUtility::getLocalArrayBounds(), getLocalArrayWithGhostBoundaries(), GenericCompositeGridOperators::getOrderOfAccuracy(), MappedGrid::getRectangularGridParameters(), BoundaryConditionParameters::ghostLineToAssign, MappedGrid::gridIndexRange(), OgesParameters::heatEquationOperator, i2, OgesParameters::isAxisymmetric, MappedGrid::isRectangular(), OgesParameters::laplaceEquation, MappedGridOperators::laplacianOperator, M, MappedGrid::mask(), max(), BCTypes::mixed, OgesParameters::mixed, OgesParameters::multigrid, multiply(), BCTypes::neumann, OgesParameters::neumann, NULL, GenericGridCollection::numberOfComponentGrids(), GridCollection::numberOfDimensions(), MappedGrid::numberOfDimensions(), BCTypes::oddSymmetry, BoundaryConditionParameters::orderOfExtrapolation, OgesParameters::orderOfExtrapolation, parameters, pow(), printF(), REAL_MIN, EquationSolver::setEquationAndBoundaryConditions(), doubleCompositeGridFunction::setIsACoefficientMatrix(), doubleCompositeGridFunction::setOperators(), GenericCompositeGridOperators::setStencilSize(), OgesParameters::solver, stencilSize, OgesParameters::THEcompatibilityConstraint, MappedGrid::THEvertex, MappedGrid::update(), doubleCompositeGridFunction::updateToMatchGrid(), updateToMatchGrid(), OgesParameters::variableHeatEquationOperator, MappedGrid::vertex(), MappedGridOperators::yDerivative, YY, and MappedGridOperators::yyDerivative.

void Oges::setEvaluateJacobian ( const int  EvaluateJacobian)

References evaluateJacobian.

int Oges::setExtraEquationValues ( realCompositeGridFunction f,
real value 
)
void Oges::setFillinRatio ( const real  fillinRatio)
void Oges::setFillinRatio2 ( const real  fillinRatio2)
void Oges::setFixupRightHandSide ( const bool  trueOrFalse)
void Oges::setGrid ( CompositeGrid cg,
bool  outOfDate = true 
)
void Oges::setGrid ( MappedGrid mg,
bool  outOfDate = true 
)
void Oges::setGridName ( const aString name)

/brief Set the name for the composite grid. /param name (input) : name for the composite grid (used for labels for e.g.)

References gridName.

int Oges::setGridsToUse ( const IntegerArray gridsToUse)
void Oges::setHarwellTolerance ( const real  harwellTolerance)
void Oges::setIterativeImprovement ( const int  trueOrFalse)
void Oges::setMatrixCutoff ( const real  matrixCutoff)
void Oges::setNullVectorScaling ( const real scale)
void Oges::setNumberOfComponents ( const int  numberOfComponents)
int Oges::setOgesParameters ( const OgesParameters opar)
void Oges::setOrderOfAccuracy ( const int  order)
void Oges::setPreconditionBoundary ( const int  preconditionBoundary)
void Oges::setPreconditionRightHandSide ( const int  preconditionRightHandSide)
void Oges::setRefactor ( const int  refactor)

References refactor.

Referenced by checkGrid().

void Oges::setReorder ( const int  reorder)

References reorder.

Referenced by checkGrid().

void Oges::setSolverJob ( const int  solverJob)

References solverJob.

void Oges::setSolverName ( const aString name)

/brief Set the name of this instance of Ogmg (for info in debug files etc.) /param name (input) : name for this instnace of Ogmg.

References solverName.

void Oges::setSolverType ( const solvers  solverType)
void Oges::setSorNumberOfIterations ( const int  sorNumberOfIterations)
void Oges::setSorOmega ( const real  sorOmega)
void Oges::setSorTolerance ( const real  sorTolerance)
void Oges::setTranspose ( const int  transpose)
void Oges::setup ( )
protected
void Oges::setZeroRatio ( const real  zeroRatio)
real Oges::sizeOf ( FILE *  file = NULL) const
virtual

References ia, max(), and NULL.

int Oges::solve ( realCompositeGridFunction u,
realCompositeGridFunction f 
)
int Oges::solve ( realMappedGridFunction u,
realMappedGridFunction f 
)
int Oges::storeSolutionIntoGridFunction ( )
int Oges::storeVector ( int  n,
real x,
realCompositeGridFunction u 
)
int Oges::update ( GenericGraphicsInterface gi,
CompositeGrid cg 
)
int Oges::updateToMatchGrid ( CompositeGrid cg)
int Oges::updateToMatchGrid ( MappedGrid mg)
int Oges::writeMatrixGridInformationToFile ( aString  fileName)
int Oges::writeMatrixToFile ( aString  fileName)
int Oges::writePetscMatrixToFile ( aString  filename,
realCompositeGridFunction u,
realCompositeGridFunction f 
)

Member Data Documentation

RealArray Oges::a
real Oges::actualFillinRatio
real Oges::actualFillinRatio2
real Oges::actualZeroRatio

Referenced by formMatrix().

int Oges::argc
char** Oges::argv
RealArray Oges::bcData
protected
IntegerArray Oges::boundaryConditions
protected
CompositeGrid Oges::cg
intArray* Oges::classify
realCompositeGridFunction* Oges::coefficientsOfDenseExtraEquations

Referenced by generateMatrix(), initialize(), and setup().

coefficientTypes Oges::coefficientType

Referenced by setCoefficientType().

RealArray Oges::constantCoefficients
protected
int Oges::debug =0
static
OgesParameters::EquationEnum Oges::equationToSolve
protected
int Oges::evaluateJacobian

Referenced by setEvaluateJacobian().

IntegerArray Oges::extraEquationNumber
IntegerArray Oges::gridEquationBase
protected
aString Oges::gridName
IntegerArray Oges::ia
int Oges::initialized
IntegerArray Oges::ja
real Oges::maximumResidual

Referenced by buildEquationSolvers(), set(), and setGrid().

int Oges::nda
int Oges::ndia
int Oges::ndja
int Oges::numberOfComponents
int Oges::numberOfDimensions
int Oges::numberOfEquations
int Oges::numberOfExtraEquations
int Oges::numberOfGrids
int Oges::numberOfIterations
int Oges::numberOfNonzeros
int Oges::numberOfNonzerosBound
OgesParameters Oges::parameters
int Oges::preconditionBoundary
int Oges::preconditionRightHandSide
bool Oges::recomputePreconditioner

Referenced by setup().

int Oges::refactor
int Oges::reorder
RealArray Oges::rhs
realCompositeGridFunction Oges::rightNullVector
bool Oges::shouldBeInitialized
RealArray Oges::sol
int Oges::solverJob
aString Oges::solverName
int Oges::solvingSparseSubset

Referenced by setup(), and YaleEquationSolver::solve().

enum Oges::SparseStorageFormatEnum Oges::sparseStorageFormat
int Oges::stencilSize
realCompositeGridFunction Oges::uLinearized
bool Oges::useAllGrids
protected
IntegerArray Oges::useThisGrid
protected

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