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

#include <OgesParameters.h>

Collaboration diagram for OgesParameters:
Collaboration graph
[legend]

Public Types

enum  EquationEnum {
  userDefined, laplaceEquation, divScalarGradOperator, heatEquationOperator,
  variableHeatEquationOperator, divScalarGradHeatEquationOperator, secondOrderConstantCoefficients
}
 
enum  BoundaryConditionEnum {
  dirichlet =1, neumann =2, mixed =3, equation =4,
  extrapolate =5, combination =6, axisymmetric, dirichletAndEvenSymmetry,
  dirichletAndOddSymmetry
}
 
enum  OptionEnum {
  THEabsoluteTolerance, THEisAxisymmetric, THEbestIterativeSolver, THEbestDirectSolver,
  THEcompatibilityConstraint, THEexternalSolver, THEfillinRatio, THEfillinRatio2,
  THEfixupRightHandSide, THEgmresRestartLength, THEharwellPivotingTolerance, THEincompleteLUExpectedFill,
  THEincompleteLUDropTolerance, THEincompleteLUSparseACoefficient, THEincompleteLUSparseFCoefficient, THEincompleteLUTypeInDH,
  THEiterativeImprovement, THEkeepCoefficientGridFunction, THEkeepSparseMatrix, THEmatrixCutoff,
  THEmatrixOrdering, THEmaximumInterpolationWidth, THEmaximumNumberOfIterations, THEminimumNumberOfIterations,
  THEnullVectorScaling, THEnumberOfIncompleteLULevels, THEorderOfExtrapolation, THEpreconditioner,
  THEparallelExternalSolver, THEparallelPreconditioner, THEparallelSolverMethod, THErelativeTolerance,
  THEremoveSolutionAndRHSVector, THEremoveSparseMatrixFactorization, THErescaleRowNorms, THEsolveForTranspose,
  THEsolverMethod, THEsolverType, THEtolerance, THEuserSuppliedCompatibilityConstraint,
  THEzeroRatio
}
 
enum  SolverEnum {
  defaultSolver, sor, yale, harwell,
  SLAP, PETSc, multigrid, PETScNew,
  userSolver1, userSolver2, userSolver3, userSolver4,
  userSolver5
}
 
enum  SolverMethodEnum {
  defaultSolverMethod, richardson, chebychev, conjugateGradient,
  cg =conjugateGradient, biConjugateGradient, bicg =biConjugateGradient, biConjugateGradientSquared,
  conjugateGradientSquared, cgs =conjugateGradientSquared, biConjugateGradientStabilized, bcgs =biConjugateGradientStabilized,
  generalizedMinimalResidual, gmres =generalizedMinimalResidual, transposeFreeQuasiMinimalResidual, tfqmr =transposeFreeQuasiMinimalResidual,
  transposeFreeQuasiMinimalResidual2, tcqmr =transposeFreeQuasiMinimalResidual2, conjugateResidual, cr =conjugateResidual,
  leastSquares, lsqr =leastSquares, preonly, qcg
}
 
enum  PreconditionerEnum {
  defaultPreconditioner, noPreconditioner, jacobiPreconditioner, sorPreconditioner,
  luPreconditioner, shellPreconditioner, DHILUPreconditioner, blockJacobiPreconditioner,
  multigridPreconditioner, eisenstatPreconditioner, incompleteCholeskyPreconditioner, incompleteLUPreconditioner,
  additiveSchwarzPreconditioner, kspPreconditioner, compositePreconditioner, redundantPreconditioner,
  diagonalPreconditioner, ssorPreconditioner, sparseApproximateInversePreconditioner, neumannNeumannPreconditioner,
  chloleskyPreconditioner, samgPreconditioner, pointBlockJacobiPreconditioner, matrixPreconditioner,
  hyprePreconditioner, fieldSplitPreconditioner, tfsPreconditioner, mlPreconditioner,
  prometheusPreconditioner
}
 
enum  MatrixOrderingEnum {
  defaultMatrixOrdering, naturalOrdering, nestedDisectionOrdering, oneWayDisectionOrdering,
  reverseCuthillMcKeeOrdering, quotientMinimumDegreeOrdering, rowlengthOrdering
}
 
enum  ExternalSolverEnum {
  defaultExternalSolver, superlu, superlu_dist, superlu_mp,
  mumps, hypre
}
 

Public Member Functions

 OgesParameters ()
 
 ~OgesParameters ()
 
OgesParametersoperator= (const OgesParameters &x)
 
aString getSolverName () const
 
aString getSolverTypeName (SolverEnum solverType=defaultSolver) const
 
aString getSolverMethodName (SolverMethodEnum solverMethod=defaultSolverMethod) const
 
aString getPreconditionerName (PreconditionerEnum preconditioner=defaultPreconditioner) const
 
aString getMatrixOrderingName (MatrixOrderingEnum matrixOrdering=defaultMatrixOrdering) const
 
int setParameters (const Oges &oges)
 
int update (GenericGraphicsInterface &gi, CompositeGrid &cg)
 
int set (SolverEnum option)
 
int set (SolverMethodEnum option)
 
int set (MatrixOrderingEnum option)
 
int set (PreconditionerEnum option)
 
int set (OptionEnum option, int value=0)
 
int set (OptionEnum option, float value)
 
int set (OptionEnum option, double value)
 
int setPetscOption (const aString &name, const aString &value)
 
bool getPetscOption (const aString &name, aString &value) const
 
SolverEnum getSolverType () const
 
int get (OptionEnum option, int &value) const
 
int get (OptionEnum option, real &value) const
 
OgmgParametersgetOgmgParameters () const
 
OgmgParametersbuildOgmgParameters ()
 
int get (const GenericDataBase &dir, const aString &name)
 
int put (GenericDataBase &dir, const aString &name) const
 
int isAvailable (SolverEnum solverType)
 
int display (FILE *file=stdout)
 

Public Attributes

ListOfShowFileParameters petscOptions
 

Protected Member Functions

int set (OptionEnum option, int value, real rvalue)
 
int get (OptionEnum option, int &value, real &rvalue) const
 

Protected Attributes

SolverEnum solver
 
aString solverName
 
SolverMethodEnum solverMethod
 
SolverMethodEnum parallelSolverMethod
 
PreconditionerEnum preconditioner
 
PreconditionerEnum parallelPreconditioner
 
MatrixOrderingEnum matrixOrdering
 
ExternalSolverEnum externalSolver
 
ExternalSolverEnum parallelExternalSolver
 
real relativeTolerance
 
real absoluteTolerance
 
real maximumAllowableIncreaseInResidual
 
bool compatibilityConstraint
 
bool userSuppliedCompatibilityConstraint
 
int gmresRestartLength
 
int numberOfIncompleteLULevels
 
real incompleteLUExpectedFill
 
int minimumNumberOfIterations
 
int maximumNumberOfIterations
 
int solveForTranspose
 
int rescaleRowNorms
 
int blockSize
 
real matrixCutoff
 
bool fixupRightHandSide
 
real zeroRatio
 
real fillinRatio
 
real fillinRatio2
 
real harwellPivotingTolerance
 
real nullVectorScaling
 
int preconditionBoundary
 
int preconditionRightHandSide
 
int maximumInterpolationWidth
 
int iterativeImprovement
 
int orderOfExtrapolation
 
real sorOmega
 
int isAxisymmetric
 
real incompleteLUDropTolerance
 
real incompleteLUSparseACoefficient
 
real incompleteLUSparseFCoefficient
 
int incompleteLUTypeInDH
 
bool keepCoefficientGridFunction
 
bool keepSparseMatrix
 
bool removeSolutionAndRHSVector
 
bool removeSparseMatrixFactorization
 
OgmgParametersogmgParameters
 

Friends

class Oges
 
class EquationSolver
 
class PETScEquationSolver
 
class YaleEquationSolver
 
class HarwellEquationSolver
 
class SlapEquationSolver
 
class Ogmg
 
class PETScSolver
 

Member Enumeration Documentation

Enumerator
dirichlet 
neumann 
mixed 
equation 
extrapolate 
combination 
axisymmetric 
dirichletAndEvenSymmetry 
dirichletAndOddSymmetry 
Enumerator
userDefined 
laplaceEquation 
divScalarGradOperator 
heatEquationOperator 
variableHeatEquationOperator 
divScalarGradHeatEquationOperator 
secondOrderConstantCoefficients 
Enumerator
defaultExternalSolver 
superlu 
superlu_dist 
superlu_mp 
mumps 
hypre 
Enumerator
defaultMatrixOrdering 
naturalOrdering 
nestedDisectionOrdering 
oneWayDisectionOrdering 
reverseCuthillMcKeeOrdering 
quotientMinimumDegreeOrdering 
rowlengthOrdering 
Enumerator
THEabsoluteTolerance 
THEisAxisymmetric 
THEbestIterativeSolver 
THEbestDirectSolver 
THEcompatibilityConstraint 
THEexternalSolver 
THEfillinRatio 
THEfillinRatio2 
THEfixupRightHandSide 
THEgmresRestartLength 
THEharwellPivotingTolerance 
THEincompleteLUExpectedFill 
THEincompleteLUDropTolerance 
THEincompleteLUSparseACoefficient 
THEincompleteLUSparseFCoefficient 
THEincompleteLUTypeInDH 
THEiterativeImprovement 
THEkeepCoefficientGridFunction 
THEkeepSparseMatrix 
THEmatrixCutoff 
THEmatrixOrdering 
THEmaximumInterpolationWidth 
THEmaximumNumberOfIterations 
THEminimumNumberOfIterations 
THEnullVectorScaling 
THEnumberOfIncompleteLULevels 
THEorderOfExtrapolation 
THEpreconditioner 
THEparallelExternalSolver 
THEparallelPreconditioner 
THEparallelSolverMethod 
THErelativeTolerance 
THEremoveSolutionAndRHSVector 
THEremoveSparseMatrixFactorization 
THErescaleRowNorms 
THEsolveForTranspose 
THEsolverMethod 
THEsolverType 
THEtolerance 
THEuserSuppliedCompatibilityConstraint 
THEzeroRatio 
Enumerator
defaultPreconditioner 
noPreconditioner 
jacobiPreconditioner 
sorPreconditioner 
luPreconditioner 
shellPreconditioner 
DHILUPreconditioner 
blockJacobiPreconditioner 
multigridPreconditioner 
eisenstatPreconditioner 
incompleteCholeskyPreconditioner 
incompleteLUPreconditioner 
additiveSchwarzPreconditioner 
kspPreconditioner 
compositePreconditioner 
redundantPreconditioner 
diagonalPreconditioner 
ssorPreconditioner 
sparseApproximateInversePreconditioner 
neumannNeumannPreconditioner 
chloleskyPreconditioner 
samgPreconditioner 
pointBlockJacobiPreconditioner 
matrixPreconditioner 
hyprePreconditioner 
fieldSplitPreconditioner 
tfsPreconditioner 
mlPreconditioner 
prometheusPreconditioner 
Enumerator
defaultSolver 
sor 
yale 
harwell 
SLAP 
PETSc 
multigrid 
PETScNew 
userSolver1 
userSolver2 
userSolver3 
userSolver4 
userSolver5 
Enumerator
defaultSolverMethod 
richardson 
chebychev 
conjugateGradient 
cg 
biConjugateGradient 
bicg 
biConjugateGradientSquared 
conjugateGradientSquared 
cgs 
biConjugateGradientStabilized 
bcgs 
generalizedMinimalResidual 
gmres 
transposeFreeQuasiMinimalResidual 
tfqmr 
transposeFreeQuasiMinimalResidual2 
tcqmr 
conjugateResidual 
cr 
leastSquares 
lsqr 
preonly 
qcg 

Constructor & Destructor Documentation

OgesParameters::OgesParameters ( )
OgesParameters::~OgesParameters ( )

References ogmgParameters.

Member Function Documentation

OgmgParameters & OgesParameters::buildOgmgParameters ( )

References NULL, and ogmgParameters.

int OgesParameters::display ( FILE *  file = stdout)
int OgesParameters::get ( OptionEnum  option,
int &  value 
) const
int OgesParameters::get ( OptionEnum  option,
real value 
) const
int OgesParameters::get ( const GenericDataBase dir,
const aString name 
)
int OgesParameters::get ( OptionEnum  option,
int &  value,
real rvalue 
) const
protected

References Overture::abort().

aString OgesParameters::getMatrixOrderingName ( MatrixOrderingEnum  matrixOrdering = defaultMatrixOrdering) const

References aString.

Referenced by display(), and getSolverName().

OgmgParameters * OgesParameters::getOgmgParameters ( ) const
bool OgesParameters::getPetscOption ( const aString name,
aString value 
) const
aString OgesParameters::getPreconditionerName ( PreconditionerEnum  preconditioner = defaultPreconditioner) const

References aString.

Referenced by display(), and getSolverName().

aString OgesParameters::getSolverMethodName ( SolverMethodEnum  solverMethod = defaultSolverMethod) const

References aString.

Referenced by display(), and getSolverName().

aString OgesParameters::getSolverName ( ) const
OgesParameters::SolverEnum OgesParameters::getSolverType ( ) const

References solver.

aString OgesParameters::getSolverTypeName ( SolverEnum  solverType = defaultSolver) const
int OgesParameters::isAvailable ( SolverEnum  solverType)

References harwell, multigrid, PETSc, PETScNew, SLAP, TRUE, and yale.

Referenced by Oges::buildEquationSolvers(), and set().

OgesParameters & OgesParameters::operator= ( const OgesParameters x)
int OgesParameters::put ( GenericDataBase dir,
const aString name 
) const
int OgesParameters::set ( SolverEnum  option)
int OgesParameters::set ( SolverMethodEnum  option)

References solverMethod.

int OgesParameters::set ( MatrixOrderingEnum  option)

References matrixOrdering.

int OgesParameters::set ( PreconditionerEnum  option)

References preconditioner.

int OgesParameters::set ( OptionEnum  option,
int  value = 0 
)
int OgesParameters::set ( OptionEnum  option,
float  value 
)
int OgesParameters::set ( OptionEnum  option,
double  value 
)
int OgesParameters::set ( OptionEnum  option,
int  value,
real  rvalue 
)
protected

References absoluteTolerance, biConjugateGradientStabilized, blockJacobiPreconditioner, compatibilityConstraint, externalSolver, fillinRatio, fillinRatio2, fixupRightHandSide, gmres, gmresRestartLength, harwellPivotingTolerance, incompleteLUDropTolerance, incompleteLUExpectedFill, incompleteLUPreconditioner, incompleteLUSparseACoefficient, incompleteLUSparseFCoefficient, incompleteLUTypeInDH, isAvailable(), isAxisymmetric, iterativeImprovement, keepCoefficientGridFunction, keepSparseMatrix, matrixCutoff, maximumInterpolationWidth, maximumNumberOfIterations, minimumNumberOfIterations, nullVectorScaling, numberOfIncompleteLULevels, orderOfExtrapolation, OV_ABORT, parallelExternalSolver, parallelPreconditioner, parallelSolverMethod, PETSc, PETScNew, preconditioner, preonly, printF(), relativeTolerance, removeSolutionAndRHSVector, removeSparseMatrixFactorization, rescaleRowNorms, SLAP, solveForTranspose, solver, solverMethod, THEabsoluteTolerance, THEbestDirectSolver, THEbestIterativeSolver, THEcompatibilityConstraint, THEexternalSolver, THEfillinRatio, THEfillinRatio2, THEfixupRightHandSide, THEgmresRestartLength, THEharwellPivotingTolerance, THEincompleteLUDropTolerance, THEincompleteLUExpectedFill, THEincompleteLUSparseACoefficient, THEincompleteLUSparseFCoefficient, THEincompleteLUTypeInDH, THEisAxisymmetric, THEiterativeImprovement, THEkeepCoefficientGridFunction, THEkeepSparseMatrix, THEmatrixCutoff, THEmatrixOrdering, THEmaximumInterpolationWidth, THEmaximumNumberOfIterations, THEminimumNumberOfIterations, THEnullVectorScaling, THEnumberOfIncompleteLULevels, THEorderOfExtrapolation, THEparallelExternalSolver, THEparallelPreconditioner, THEparallelSolverMethod, THEpreconditioner, THErelativeTolerance, THEremoveSolutionAndRHSVector, THEremoveSparseMatrixFactorization, THErescaleRowNorms, THEsolveForTranspose, THEsolverMethod, THEsolverType, THEtolerance, THEuserSuppliedCompatibilityConstraint, THEzeroRatio, userSuppliedCompatibilityConstraint, yale, and zeroRatio.

int OgesParameters::setParameters ( const Oges oges)
int OgesParameters::setPetscOption ( const aString name,
const aString value 
)

References petscOptions.

int OgesParameters::update ( GenericGraphicsInterface gi,
CompositeGrid cg 
)

References absoluteTolerance, additiveSchwarzPreconditioner, GenericGraphicsInterface::appendToTheDefaultPrompt(), aString, biConjugateGradient, biConjugateGradientSquared, biConjugateGradientStabilized, blockJacobiPreconditioner, blockSize, chebychev, compositePreconditioner, conjugateGradient, conjugateGradientSquared, conjugateResidual, Oges::debug, diagonalPreconditioner, eisenstatPreconditioner, externalSolver, fillinRatio, fillinRatio2, GenericGraphicsInterface::getMenuItem(), getSolverName(), gmres, gmresRestartLength, harwell, hypre, incompleteCholeskyPreconditioner, incompleteLUDropTolerance, incompleteLUExpectedFill, incompleteLUPreconditioner, incompleteLUSparseACoefficient, incompleteLUSparseFCoefficient, incompleteLUTypeInDH, GenericGraphicsInterface::inputString(), jacobiPreconditioner, kspPreconditioner, leastSquares, luPreconditioner, matrixCutoff, max(), maximumAllowableIncreaseInResidual, maximumNumberOfIterations, minimumNumberOfIterations, multigrid, multigridPreconditioner, mumps, naturalOrdering, nestedDisectionOrdering, noPreconditioner, NULL, nullVectorScaling, numberOfIncompleteLULevels, ogmgParameters, oneWayDisectionOrdering, GenericGraphicsInterface::outputString(), parallelExternalSolver, parallelPreconditioner, parallelSolverMethod, PETSc, PETScNew, petscOptions, preonly, printF(), qcg, quotientMinimumDegreeOrdering, redundantPreconditioner, relativeTolerance, rescaleRowNorms, reverseCuthillMcKeeOrdering, richardson, rowlengthOrdering, shellPreconditioner, SLAP, solver, solverMethod, sor, sorOmega, sorPreconditioner, sPrintF(), sScanF(), ssorPreconditioner, GenericGraphicsInterface::stopReadingCommandFile(), superlu, superlu_dist, superlu_mp, tcqmr, tfqmr, THEbestDirectSolver, THEbestIterativeSolver, THEcompatibilityConstraint, THEincompleteLUDropTolerance, THEincompleteLUSparseACoefficient, THEincompleteLUSparseFCoefficient, THEincompleteLUTypeInDH, THEiterativeImprovement, THEmatrixOrdering, THEpreconditioner, THEsolveForTranspose, THEsolverMethod, THEsolverType, GenericGraphicsInterface::unAppendTheDefaultPrompt(), OgmgParameters::update(), yale, and zeroRatio.

Referenced by Oges::update(), and OgmgParameters::update().

Friends And Related Function Documentation

friend class EquationSolver
friend
friend class HarwellEquationSolver
friend
friend class Oges
friend
friend class Ogmg
friend
friend class PETScEquationSolver
friend
friend class PETScSolver
friend
friend class SlapEquationSolver
friend
friend class YaleEquationSolver
friend

Member Data Documentation

real OgesParameters::absoluteTolerance
protected
int OgesParameters::blockSize
protected

Referenced by OgesParameters(), operator=(), and update().

bool OgesParameters::compatibilityConstraint
protected
ExternalSolverEnum OgesParameters::externalSolver
protected

Referenced by OgesParameters(), operator=(), set(), and update().

real OgesParameters::fillinRatio
protected
real OgesParameters::fillinRatio2
protected
bool OgesParameters::fixupRightHandSide
protected
int OgesParameters::gmresRestartLength
protected
real OgesParameters::harwellPivotingTolerance
protected
real OgesParameters::incompleteLUDropTolerance
protected

Referenced by OgesParameters(), operator=(), set(), and update().

real OgesParameters::incompleteLUExpectedFill
protected

Referenced by OgesParameters(), operator=(), set(), and update().

real OgesParameters::incompleteLUSparseACoefficient
protected

Referenced by OgesParameters(), operator=(), set(), and update().

real OgesParameters::incompleteLUSparseFCoefficient
protected

Referenced by OgesParameters(), operator=(), set(), and update().

int OgesParameters::incompleteLUTypeInDH
protected

Referenced by OgesParameters(), operator=(), set(), and update().

int OgesParameters::isAxisymmetric
protected
int OgesParameters::iterativeImprovement
protected
bool OgesParameters::keepCoefficientGridFunction
protected
bool OgesParameters::keepSparseMatrix
protected
real OgesParameters::matrixCutoff
protected
MatrixOrderingEnum OgesParameters::matrixOrdering
protected

Referenced by OgesParameters(), operator=(), and set().

real OgesParameters::maximumAllowableIncreaseInResidual
protected
int OgesParameters::maximumInterpolationWidth
protected
int OgesParameters::maximumNumberOfIterations
protected
int OgesParameters::minimumNumberOfIterations
protected
real OgesParameters::nullVectorScaling
protected
int OgesParameters::numberOfIncompleteLULevels
protected
OgmgParameters* OgesParameters::ogmgParameters
protected
int OgesParameters::orderOfExtrapolation
protected
ExternalSolverEnum OgesParameters::parallelExternalSolver
protected

Referenced by OgesParameters(), operator=(), set(), and update().

PreconditionerEnum OgesParameters::parallelPreconditioner
protected
SolverMethodEnum OgesParameters::parallelSolverMethod
protected
ListOfShowFileParameters OgesParameters::petscOptions

Referenced by operator=(), setPetscOption(), and update().

int OgesParameters::preconditionBoundary
protected

Referenced by OgesParameters(), and operator=().

PreconditionerEnum OgesParameters::preconditioner
protected
int OgesParameters::preconditionRightHandSide
protected

Referenced by OgesParameters(), and operator=().

real OgesParameters::relativeTolerance
protected
bool OgesParameters::removeSolutionAndRHSVector
protected

Referenced by OgesParameters(), operator=(), and set().

bool OgesParameters::removeSparseMatrixFactorization
protected

Referenced by OgesParameters(), operator=(), and set().

int OgesParameters::rescaleRowNorms
protected
int OgesParameters::solveForTranspose
protected
SolverEnum OgesParameters::solver
protected
SolverMethodEnum OgesParameters::solverMethod
protected
aString OgesParameters::solverName
protected

Referenced by OgesParameters(), operator=(), and set().

real OgesParameters::sorOmega
protected
bool OgesParameters::userSuppliedCompatibilityConstraint
protected
real OgesParameters::zeroRatio
protected

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