Table of contents
General
Functions, Macros
- getBlockNodeIDList
This function returns the node identifiers given the element block
- getBlockNodeSolution
This function returns the nodal solutions given the element block number
- getNumBlockActEqns
This function returns the number of unknowns given the element block
- getNumBlockActNodes
This function returns the number of nodes given the element block
- HYPRE_BoomerAMGCreate
Create a solver object
- HYPRE_BoomerAMGDestroy
Destroy a solver object
- HYPRE_BoomerAMGGetFinalRelativeResidualNorm
Returns the norm of the final relative residual
- HYPRE_BoomerAMGGetNumIterations
Returns the number of iterations taken
- HYPRE_BoomerAMGSetAggNumLevels
(Optional) Defines the number of levels of aggressive coarsening
- HYPRE_BoomerAMGSetCoarsenType
(Optional) Defines which parallel coarsening algorithm is used
- HYPRE_BoomerAMGSetCycleNumSweeps
(Optional) Sets the number of sweeps at a specified cycle
- HYPRE_BoomerAMGSetCycleRelaxType
(Optional) Defines the smoother at a given cycle
- HYPRE_BoomerAMGSetCycleType
(Optional) Defines the type of cycle
- HYPRE_BoomerAMGSetDebugFlag
(Optional)
- HYPRE_BoomerAMGSetDofFunc
(Optional) Sets the mapping that assigns the function to each variable,
if using the systems version
- HYPRE_BoomerAMGSetDomainType
(Optional) Defines the type of domain used for the Schwarz method
- HYPRE_BoomerAMGSetDropTol
(Optional) Defines drop tolerance for PILUT
- HYPRE_BoomerAMGSetEuclidFile
(Optional) Defines name of an input file for Euclid parameters
- HYPRE_BoomerAMGSetFilter
(Optional) Defines filter for ParaSAILS
- HYPRE_BoomerAMGSetGridRelaxPoints
(Optional) Defines in which order the points are relaxed
- HYPRE_BoomerAMGSetGridRelaxType
(Optional) Defines which smoother is used on the fine and coarse grid,
the up and down cycle
- HYPRE_BoomerAMGSetGSMG
(Optional) Specifies the use of GSMG - geometrically smooth
coarsening and interpolation
- HYPRE_BoomerAMGSetLevel
(Optional) Defines number of levels for ParaSAILS
- HYPRE_BoomerAMGSetLevelOuterWt
(Optional) Defines the outer relaxation weight for hybrid SOR or SSOR
on the user defined level
- HYPRE_BoomerAMGSetLevelRelaxWt
(Optional) Defines the relaxation weight for smoothed Jacobi and hybrid SOR
on the user defined level
- HYPRE_BoomerAMGSetLogging
(Optional) Requests additional computations for diagnostic and similar
data to be logged by the user
- HYPRE_BoomerAMGSetMaxIter
(Optional) Sets maximum number of iterations, if BoomerAMG is used
as a solver
- HYPRE_BoomerAMGSetMaxLevels
(Optional) Sets maximum number of multigrid levels
- HYPRE_BoomerAMGSetMaxNzPerRow
(Optional) Defines maximal number of nonzeros for PILUT
- HYPRE_BoomerAMGSetMaxRowSum
(Optional) Sets a parameter to modify the definition of strength for
diagonal dominant portions of the matrix
- HYPRE_BoomerAMGSetMeasureType
(Optional) Defines whether local or global measures are used
- HYPRE_BoomerAMGSetNodal
(Optional) Sets whether to use the nodal systems version
- HYPRE_BoomerAMGSetNumFunctions
(Optional) Sets the size of the system of PDEs, if using the systems version
- HYPRE_BoomerAMGSetNumGridSweeps
(Optional) Defines the number of sweeps for the fine and coarse grid,
the up and down cycle
- HYPRE_BoomerAMGSetNumPaths
(Optional) Defines the degree of aggressive coarsening
- HYPRE_BoomerAMGSetNumSamples
(Optional) Defines the number of sample vectors used in GSMG
or LS interpolation
- HYPRE_BoomerAMGSetNumSweeps
(Optional) Sets the number of sweeps
- HYPRE_BoomerAMGSetOmega
(Optional) Defines the outer relaxation weight for hybrid SOR
- HYPRE_BoomerAMGSetOuterWt
(Optional) Defines the outer relaxation weight for hybrid SOR and SSOR
on all levels
- HYPRE_BoomerAMGSetOverlap
(Optional) Defines the overlap for the Schwarz method
- HYPRE_BoomerAMGSetPrintLevel
(Optional) Requests automatic printing of solver performance and
debugging data; default to 0 for no printing
- HYPRE_BoomerAMGSetRelaxOrder
(Optional) Defines in which order the points are relaxed
- HYPRE_BoomerAMGSetRelaxType
(Optional) Defines the smoother to be used
- HYPRE_BoomerAMGSetRelaxWeight
(Optional) Defines the relaxation weight for smoothed Jacobi and hybrid SOR
- HYPRE_BoomerAMGSetRelaxWt
(Optional) Defines the relaxation weight for smoothed Jacobi and hybrid SOR
on all levels
- HYPRE_BoomerAMGSetSchwarzRlxWeight
(Optional) Defines a smoothing parameter for the additive Schwarz method
- HYPRE_BoomerAMGSetSCommPkgSwitch
(Optional) Defines the largest strength threshold for which
the strength matrix S uses the communication package of the operator A
- HYPRE_BoomerAMGSetSmoothNumLevels
(Optional) Sets the number of levels for more complex smoothers
- HYPRE_BoomerAMGSetSmoothNumSweeps
(Optional) Sets the number of sweeps for more complex smoothers
- HYPRE_BoomerAMGSetSmoothType
(Optional) Enables the use of more complex smoothers
- HYPRE_BoomerAMGSetStrongThreshold
(Optional) Sets AMG strength threshold
- HYPRE_BoomerAMGSetSym
(Optional) Defines symmetry for ParaSAILS
- HYPRE_BoomerAMGSetThreshold
(Optional) Defines threshold for ParaSAILS
- HYPRE_BoomerAMGSetTol
(Optional) Set the convergence tolerance, if BoomerAMG is used
as a solver
- HYPRE_BoomerAMGSetTruncFactor
(Optional) Defines a truncation factor for the interpolation
- HYPRE_BoomerAMGSetup
Set up the BoomerAMG solver or preconditioner
- HYPRE_BoomerAMGSetVariant
(Optional) Defines which variant of the Schwarz method is used
- HYPRE_BoomerAMGSolve
Solve the system or apply AMG as a preconditioner
- HYPRE_BoomerAMGSolveT
Solve the transpose system
or apply AMG as a preconditioner
to the transpose system
- HYPRE_EuclidCreate
Create a Euclid object
- HYPRE_EuclidDestroy
Destroy a Euclid object
- HYPRE_EuclidSetParams
Insert (name, value) pairs in Euclid's options database
by passing Euclid the command line (or an array of strings)
- HYPRE_EuclidSetParamsFromFile
Insert (name, value) pairs in Euclid's options database
- HYPRE_EuclidSetup
Set up the Euclid preconditioner
- HYPRE_EuclidSolve
Apply the Euclid preconditioner
- HYPRE_IJMatrixAddToValues
Adds to values for nrows rows or partial rows of the matrix
- HYPRE_IJMatrixAssemble
Finalize the construction of the matrix before using
- HYPRE_IJMatrixCreate
Create a matrix object
- HYPRE_IJMatrixDestroy
Destroy a matrix object
- HYPRE_IJMatrixGetLocalRange
Gets range of rows owned by this processor and range
of column partitioning for this processor
- HYPRE_IJMatrixGetObject
Get a reference to the constructed matrix object
- HYPRE_IJMatrixGetObjectType
Get the storage type of the constructed matrix object
- HYPRE_IJMatrixGetRowCounts
Gets number of nonzeros elements for nrows rows specified in rows
and returns them in ncols, which needs to be allocated by the
user
- HYPRE_IJMatrixGetValues
Gets values for nrows rows or partial rows of the matrix
- HYPRE_IJMatrixInitialize
Prepare a matrix object for setting coefficient values
- HYPRE_IJMatrixPrint
Print the matrix to file
- HYPRE_IJMatrixRead
Read the matrix from file
- HYPRE_IJMatrixSetDiagOffdSizes
(Optional) Set the max number of nonzeros to expect in each row of
the diagonal and off-diagonal blocks
- HYPRE_IJMatrixSetMaxOffProcElmts
(Optional) Sets the maximum number of elements that are expected to be set
(or added) on other processors from this processor
This routine can significantly improve the efficiency of matrix
construction, and should always be utilized if possible
- HYPRE_IJMatrixSetObjectType
Set the storage type of the matrix object to be constructed
- HYPRE_IJMatrixSetRowSizes
(Optional) Set the max number of nonzeros to expect in each row
- HYPRE_IJMatrixSetValues
Sets values for nrows rows or partial rows of the matrix
- HYPRE_IJVectorAddToValues
Adds to values in vector
- HYPRE_IJVectorAssemble
Finalize the construction of the vector before using
- HYPRE_IJVectorCreate
Create a vector object
- HYPRE_IJVectorDestroy
Destroy a vector object
- HYPRE_IJVectorGetLocalRange
Returns range of the part of the vector owned by this processor
- HYPRE_IJVectorGetObject
Get a reference to the constructed vector object
- HYPRE_IJVectorGetObjectType
Get the storage type of the constructed vector object
- HYPRE_IJVectorGetValues
Gets values in vector
- HYPRE_IJVectorInitialize
Prepare a vector object for setting coefficient values
- HYPRE_IJVectorPrint
Print the vector to file
- HYPRE_IJVectorRead
Read the vector from file
- HYPRE_IJVectorSetMaxOffProcElmts
(Optional) Sets the maximum number of elements that are expected to be set
(or added) on other processors from this processor
This routine can significantly improve the efficiency of matrix
construction, and should always be utilized if possible
- HYPRE_IJVectorSetObjectType
Set the storage type of the vector object to be constructed
- HYPRE_IJVectorSetValues
Sets values in vector
- HYPRE_ParaSailsBuildIJMatrix
Build IJ Matrix of the sparse approximate inverse (factor)
- HYPRE_ParaSailsCreate
Create a ParaSails preconditioner
- HYPRE_ParaSailsDestroy
Destroy a ParaSails preconditioner
- HYPRE_ParaSailsSetFilter
Set the filter parameter for the
ParaSails preconditioner
- HYPRE_ParaSailsSetLoadbal
Set the load balance parameter for the
ParaSails preconditioner
- HYPRE_ParaSailsSetLogging
Set the logging parameter for the
ParaSails preconditioner
- HYPRE_ParaSailsSetParams
Set the threshold and levels parameter for the ParaSails
preconditioner
- HYPRE_ParaSailsSetReuse
Set the pattern reuse parameter for the
ParaSails preconditioner
- HYPRE_ParaSailsSetSym
Set the symmetry parameter for the
ParaSails preconditioner
- HYPRE_ParaSailsSetup
Set up the ParaSails preconditioner
- HYPRE_ParaSailsSolve
Apply the ParaSails preconditioner
- HYPRE_ParCSRDiagScale
Solve routine for diagonal preconditioning
- HYPRE_ParCSRDiagScaleSetup
Setup routine for diagonal preconditioning
- HYPRE_ParCSRGMRESCreate
Create a solver object
- HYPRE_ParCSRGMRESDestroy
Destroy a solver object
- HYPRE_ParCSRGMRESGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_ParCSRGMRESGetNumIterations
Return the number of iterations taken
- HYPRE_ParCSRGMRESGetPrecond
- HYPRE_ParCSRGMRESSetKDim
(Optional) Set the maximum size of the Krylov space
- HYPRE_ParCSRGMRESSetLogging
(Optional) Set the amount of logging to do
- HYPRE_ParCSRGMRESSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_ParCSRGMRESSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_ParCSRGMRESSetPrintLevel
(Optional) Set print level
- HYPRE_ParCSRGMRESSetTol
(Optional) Set the convergence tolerance
- HYPRE_ParCSRGMRESSetup
- HYPRE_ParCSRGMRESSolve
Solve the system
- HYPRE_ParCSRPCGCreate
Create a solver object
- HYPRE_ParCSRPCGDestroy
Destroy a solver object
- HYPRE_ParCSRPCGGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_ParCSRPCGGetNumIterations
Return the number of iterations taken
- HYPRE_ParCSRPCGGetPrecond
- HYPRE_ParCSRPCGSetLogging
(Optional) Set the amount of logging to do
- HYPRE_ParCSRPCGSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_ParCSRPCGSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_ParCSRPCGSetPrintLevel
(Optional) Set the print level
- HYPRE_ParCSRPCGSetRelChange
(Optional) Additionally require that the relative difference in
successive iterates be small
- HYPRE_ParCSRPCGSetTol
(Optional) Set the convergence tolerance
- HYPRE_ParCSRPCGSetTwoNorm
(Optional) Use the two-norm in stopping criteria
- HYPRE_ParCSRPCGSetup
- HYPRE_ParCSRPCGSolve
Solve the system
- HYPRE_ParCSRPilutCreate
Create a preconditioner object
- HYPRE_ParCSRPilutDestroy
Destroy a preconditioner object
- HYPRE_ParCSRPilutSetDropTolerance
(Optional)
- HYPRE_ParCSRPilutSetFactorRowSize
(Optional)
- HYPRE_ParCSRPilutSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_ParCSRPilutSetup
- HYPRE_ParCSRPilutSolve
Precondition the system
- HYPRE_SStructBiCGSTABCreate
Create a solver object
- HYPRE_SStructBiCGSTABDestroy
Destroy a solver object
- HYPRE_SStructBiCGSTABGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_SStructBiCGSTABGetNumIterations
Return the number of iterations taken
- HYPRE_SStructBiCGSTABGetResidual
Return the residual
- HYPRE_SStructBiCGSTABSetLogging
(Optional) Set the amount of logging to do
- HYPRE_SStructBiCGSTABSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_SStructBiCGSTABSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_SStructBiCGSTABSetPrintLevel
(Optional) Set the print level
- HYPRE_SStructBiCGSTABSetTol
(Optional) Set the convergence tolerance
- HYPRE_SStructBiCGSTABSetup
- HYPRE_SStructBiCGSTABSolve
Solve the system
- HYPRE_SStructFACCreate
Create a FAC solver object
- HYPRE_SStructFACDestroy2
Destroy a FAC solver object
- HYPRE_SStructFACGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_SStructFACGetNumIterations
Return the number of iterations taken
- HYPRE_SStructFACSetCoarseSolverType
(Optional) Set coarsest solver type
- HYPRE_SStructFACSetLogging
(Optional) Set the amount of logging to do
- HYPRE_SStructFACSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_SStructFACSetMaxLevels
(Optional) Set max FAC levels
- HYPRE_SStructFACSetNonZeroGuess
(Optional) Use a nonzero initial guess
- HYPRE_SStructFACSetNumPostRelax
(Optional) Set number of post-relaxation sweeps
- HYPRE_SStructFACSetNumPreRelax
(Optional) Set number of pre-relaxation sweeps
- HYPRE_SStructFACSetPLevels
Set up amr structure
- HYPRE_SStructFACSetPRefinements
Set up amr refinement factors
- HYPRE_SStructFACSetRelaxType
(Optional) Set relaxation type
- HYPRE_SStructFACSetRelChange
(Optional) Additionally require that the relative difference in
successive iterates be small
- HYPRE_SStructFACSetTol
(Optional) Set the convergence tolerance
- HYPRE_SStructFACSetup2
Set up the FAC solver structure
- HYPRE_SStructFACSetZeroGuess
(Optional) Use a zero initial guess
- HYPRE_SStructFACSolve3
Solve the system
- HYPRE_SStructGMRESCreate
Create a solver object
- HYPRE_SStructGMRESDestroy
Destroy a solver object
- HYPRE_SStructGMRESGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_SStructGMRESGetNumIterations
Return the number of iterations taken
- HYPRE_SStructGMRESGetResidual
Return the residual
- HYPRE_SStructGMRESSetKDim
(Optional) Set the maximum size of the Krylov space
- HYPRE_SStructGMRESSetLogging
(Optional) Set the amount of logging to do
- HYPRE_SStructGMRESSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_SStructGMRESSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_SStructGMRESSetPrintLevel
(Optional) Set the print level
- HYPRE_SStructGMRESSetTol
(Optional) Set the convergence tolerance
- HYPRE_SStructGMRESSetup
- HYPRE_SStructGMRESSolve
Solve the system
- HYPRE_SStructGraphAddEntries
Add a non-stencil graph entry at a particular index
- HYPRE_SStructGraphAssemble
Finalize the construction of the graph before using
- HYPRE_SStructGraphCreate
Create a graph object
- HYPRE_SStructGraphDestroy
Destroy a graph object
- HYPRE_SStructGraphSetObjectType
It is used before AddEntries and Assemble
to compute the right ranks in the graph
- HYPRE_SStructGraphSetStencil
Set the stencil for a variable on a structured part of the grid
- HYPRE_SStructGridAddUnstructuredPart
Add an unstructured part to the grid
- HYPRE_SStructGridAddVariables
Describe additional variables that live at a particular index
- HYPRE_SStructGridAssemble
Finalize the construction of the grid before using
- HYPRE_SStructGridCreate
Create an ndim-dimensional grid object with nparts
structured parts
- HYPRE_SStructGridDestroy
Destroy a grid object
- HYPRE_SStructGridSetExtents
Set the extents for a box on a structured part of the grid
- HYPRE_SStructGridSetNeighborBox
Describe how regions just outside of a part relate to other parts
- HYPRE_SStructGridSetNumGhost
Setting ghost in the sgrids
- HYPRE_SStructGridSetPeriodic
(Optional) Set periodic for a particular part
- HYPRE_SStructGridSetVariables
Describe the variables that live on a structured part of the grid
- HYPRE_SStructMatrixAddToBoxValues
Add to matrix coefficients a box at a time
- HYPRE_SStructMatrixAddToValues
Add to matrix coefficients index by index
- HYPRE_SStructMatrixAssemble
Finalize the construction of the matrix before using
- HYPRE_SStructMatrixCreate
Create a matrix object
- HYPRE_SStructMatrixDestroy
Destroy a matrix object
- HYPRE_SStructMatrixGetObject
Get a reference to the constructed matrix object
- HYPRE_SStructMatrixInitialize
Prepare a matrix object for setting coefficient values
- HYPRE_SStructMatrixPrint
Print the matrix to file
- HYPRE_SStructMatrixSetBoxValues
Set matrix coefficients a box at a time
- HYPRE_SStructMatrixSetComplex
Set the matrix to be complex
- HYPRE_SStructMatrixSetNSSymmetric
Define symmetry properties for all non-stencil matrix entries
- HYPRE_SStructMatrixSetObjectType
Set the storage type of the matrix object to be constructed
- HYPRE_SStructMatrixSetSymmetric
Define symmetry properties for the stencil entries in the matrix
- HYPRE_SStructMatrixSetValues
Set matrix coefficients index by index
- HYPRE_SStructPCGCreate
Create a solver object
- HYPRE_SStructPCGDestroy
Destroy a solver object
- HYPRE_SStructPCGGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_SStructPCGGetNumIterations
Return the number of iterations taken
- HYPRE_SStructPCGGetResidual
Return the residual
- HYPRE_SStructPCGSetLogging
(Optional) Set the amount of logging to do
- HYPRE_SStructPCGSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_SStructPCGSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_SStructPCGSetPrintLevel
(Optional) Set the print level
- HYPRE_SStructPCGSetRelChange
(Optional) Set to use additional relative-change convergence test
- HYPRE_SStructPCGSetTol
(Optional) Set the convergence tolerance
- HYPRE_SStructPCGSetTwoNorm
(Optional) Set type of norm to use in stopping criteria
- HYPRE_SStructPCGSetup
- HYPRE_SStructPCGSolve
Solve the system
- HYPRE_SStructStencilCreate
Create a stencil object for the specified number of spatial dimensions
and stencil entries
- HYPRE_SStructStencilDestroy
Destroy a stencil object
- HYPRE_SStructStencilSetEntry
Set a stencil entry
- HYPRE_SStructSysPFMGCreate
Create a solver object
- HYPRE_SStructSysPFMGDestroy
Destroy a solver object
- HYPRE_SStructSysPFMGGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_SStructSysPFMGGetNumIterations
Return the number of iterations taken
- HYPRE_SStructSysPFMGSetLogging
(Optional) Set the amount of logging to do
- HYPRE_SStructSysPFMGSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_SStructSysPFMGSetNonZeroGuess
(Optional) Use a nonzero initial guess
- HYPRE_SStructSysPFMGSetNumPostRelax
(Optional) Set number of post-relaxation sweeps
- HYPRE_SStructSysPFMGSetNumPreRelax
(Optional) Set number of pre-relaxation sweeps
- HYPRE_SStructSysPFMGSetPrintLevel
(Optional) Set the print level
- HYPRE_SStructSysPFMGSetRelaxType
(Optional) Set relaxation type
- HYPRE_SStructSysPFMGSetRelChange
(Optional) Additionally require that the relative difference in
successive iterates be small
- HYPRE_SStructSysPFMGSetSkipRelax
(Optional) Skip relaxation on certain grids for isotropic problems
- HYPRE_SStructSysPFMGSetTol
(Optional) Set the convergence tolerance
- HYPRE_SStructSysPFMGSetup
- HYPRE_SStructSysPFMGSetZeroGuess
(Optional) Use a zero initial guess
- HYPRE_SStructSysPFMGSolve
Solve the system
- HYPRE_SStructVectorAddToBoxValues
Set vector coefficients a box at a time
- HYPRE_SStructVectorAddToValues
Set vector coefficients index by index
- HYPRE_SStructVectorAssemble
Finalize the construction of the vector before using
- HYPRE_SStructVectorCreate
Create a vector object
- HYPRE_SStructVectorDestroy
Destroy a vector object
- HYPRE_SStructVectorGather
Gather vector data so that efficient GetValues can be done
- HYPRE_SStructVectorGetBoxValues
Get vector coefficients a box at a time
- HYPRE_SStructVectorGetObject
Get a reference to the constructed vector object
- HYPRE_SStructVectorGetValues
Get vector coefficients index by index
- HYPRE_SStructVectorInitialize
Prepare a vector object for setting coefficient values
- HYPRE_SStructVectorPrint
Print the vector to file
- HYPRE_SStructVectorSetBoxValues
Set vector coefficients a box at a time
- HYPRE_SStructVectorSetComplex
Set the vector to be complex
- HYPRE_SStructVectorSetObjectType
Set the storage type of the vector object to be constructed
- HYPRE_SStructVectorSetValues
Set vector coefficients index by index
- HYPRE_StructBiCGSTABCreate
Create a solver object
- HYPRE_StructBiCGSTABDestroy
Destroy a solver object
- HYPRE_StructBiCGSTABGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_StructBiCGSTABGetNumIterations
Return the number of iterations taken
- HYPRE_StructBiCGSTABGetResidual
Return the residual
- HYPRE_StructBiCGSTABSetLogging
(Optional) Set the amount of logging to do
- HYPRE_StructBiCGSTABSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_StructBiCGSTABSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_StructBiCGSTABSetPrintLevel
(Optional) Set the print level
- HYPRE_StructBiCGSTABSetTol
(Optional) Set the convergence tolerance
- HYPRE_StructBiCGSTABSetup
set up
- HYPRE_StructBiCGSTABSolve
Solve the system
- HYPRE_StructDiagScale
Solve routine for diagonal preconditioning
- HYPRE_StructDiagScaleSetup
Setup routine for diagonal preconditioning
- HYPRE_StructGMRESCreate
Create a solver object
- HYPRE_StructGMRESDestroy
Destroy a solver object
- HYPRE_StructGMRESGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_StructGMRESGetNumIterations
Return the number of iterations taken
- HYPRE_StructGMRESGetResidual
Return the residual
- HYPRE_StructGMRESSetLogging
(Optional) Set the amount of logging to do
- HYPRE_StructGMRESSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_StructGMRESSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_StructGMRESSetPrintLevel
(Optional) Set the print level
- HYPRE_StructGMRESSetTol
(Optional) Set the convergence tolerance
- HYPRE_StructGMRESSetup
set up
- HYPRE_StructGMRESSolve
Solve the system
- HYPRE_StructGridAssemble
Finalize the construction of the grid before using
- HYPRE_StructGridCreate
Create an ndim-dimensional grid object
- HYPRE_StructGridDestroy
Destroy a grid object
- HYPRE_StructGridSetExtents
Set the extents for a box on the grid
- HYPRE_StructGridSetNumGhost
(Optional) Set the ghost layer in the grid object
- HYPRE_StructGridSetPeriodic
(Optional) Set periodic
- HYPRE_StructJacobiCreate
Create a solver object
- HYPRE_StructJacobiDestroy
Destroy a solver object
- HYPRE_StructJacobiGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_StructJacobiGetNumIterations
Return the number of iterations taken
- HYPRE_StructJacobiSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_StructJacobiSetNonZeroGuess
(Optional) Use a nonzero initial guess
- HYPRE_StructJacobiSetTol
(Optional) Set the convergence tolerance
- HYPRE_StructJacobiSetup
- HYPRE_StructJacobiSetZeroGuess
(Optional) Use a zero initial guess
- HYPRE_StructJacobiSolve
Solve the system
- HYPRE_StructMatrixAddToBoxValues
Add to matrix coefficients a box at a time
- HYPRE_StructMatrixAddToConstantValues
Add to matrix coefficients which are constant over the grid
- HYPRE_StructMatrixAddToValues
Add to matrix coefficients index by index
- HYPRE_StructMatrixAssemble
Finalize the construction of the matrix before using
- HYPRE_StructMatrixCreate
Create a matrix object
- HYPRE_StructMatrixDestroy
Destroy a matrix object
- HYPRE_StructMatrixInitialize
Prepare a matrix object for setting coefficient values
- HYPRE_StructMatrixPrint
Print the matrix to file
- HYPRE_StructMatrixSetBoxValues
Set matrix coefficients a box at a time
- HYPRE_StructMatrixSetConstantEntries
Specifiy which stencil entries are constant over the grid
- HYPRE_StructMatrixSetConstantValues
Set matrix coefficients which are constant over the grid
- HYPRE_StructMatrixSetNumGhost
(Optional) Set the ghost layer in the matrix
- HYPRE_StructMatrixSetSymmetric
(Optional) Define symmetry properties of the matrix
- HYPRE_StructMatrixSetValues
Set matrix coefficients index by index
- HYPRE_StructPCGCreate
Create a solver object
- HYPRE_StructPCGDestroy
Destroy a solver object
- HYPRE_StructPCGGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_StructPCGGetNumIterations
Return the number of iterations taken
- HYPRE_StructPCGGetResidual
Return the residual
- HYPRE_StructPCGSetLogging
(Optional) Set the amount of logging to do
- HYPRE_StructPCGSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_StructPCGSetPrecond
(Optional) Set the preconditioner to use
- HYPRE_StructPCGSetPrintLevel
(Optional) Set the print level
- HYPRE_StructPCGSetRelChange
(Optional) Additionally require that the relative difference in
successive iterates be small
- HYPRE_StructPCGSetTol
(Optional) Set the convergence tolerance
- HYPRE_StructPCGSetTwoNorm
(Optional) Use the two-norm in stopping criteria
- HYPRE_StructPCGSetup
- HYPRE_StructPCGSolve
Solve the system
- HYPRE_StructPFMGCreate
Create a solver object
- HYPRE_StructPFMGDestroy
Destroy a solver object
- HYPRE_StructPFMGGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_StructPFMGGetNumIterations
Return the number of iterations taken
- HYPRE_StructPFMGSetLogging
(Optional) Set the amount of logging to do
- HYPRE_StructPFMGSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_StructPFMGSetNonZeroGuess
(Optional) Use a nonzero initial guess
- HYPRE_StructPFMGSetNumPostRelax
(Optional) Set number of post-relaxation sweeps
- HYPRE_StructPFMGSetNumPreRelax
(Optional) Set number of pre-relaxation sweeps
- HYPRE_StructPFMGSetPrintLevel
(Optional) To allow printing to the screen
- HYPRE_StructPFMGSetRAPType
(Optional) Set type of code used for coarse operator
- HYPRE_StructPFMGSetRelaxType
(Optional) Set relaxation type
- HYPRE_StructPFMGSetRelChange
(Optional) Additionally require that the relative difference in
successive iterates be small
- HYPRE_StructPFMGSetSkipRelax
(Optional) Skip relaxation on certain grids for isotropic problems
- HYPRE_StructPFMGSetTol
(Optional) Set the convergence tolerance
- HYPRE_StructPFMGSetup
- HYPRE_StructPFMGSetZeroGuess
(Optional) Use a zero initial guess
- HYPRE_StructPFMGSolve
Solve the system
- HYPRE_StructSMGCreate
Create a solver object
- HYPRE_StructSMGDestroy
Destroy a solver object
- HYPRE_StructSMGGetFinalRelativeResidualNorm
Return the norm of the final relative residual
- HYPRE_StructSMGGetNumIterations
Return the number of iterations taken
- HYPRE_StructSMGSetLogging
(Optional) Set the amount of logging to do
- HYPRE_StructSMGSetMaxIter
(Optional) Set maximum number of iterations
- HYPRE_StructSMGSetNonZeroGuess
(Optional) Use a nonzero initial guess
- HYPRE_StructSMGSetNumPostRelax
(Optional) Set number of post-relaxation sweeps
- HYPRE_StructSMGSetNumPreRelax
(Optional) Set number of pre-relaxation sweeps
- HYPRE_StructSMGSetPrintLevel
(Optional) To allow printing to the screen
- HYPRE_StructSMGSetRelChange
(Optional) Additionally require that the relative difference in
successive iterates be small
- HYPRE_StructSMGSetTol
(Optional) Set the convergence tolerance
- HYPRE_StructSMGSetup
- HYPRE_StructSMGSetZeroGuess
(Optional) Use a zero initial guess
- HYPRE_StructSMGSolve
Solve the system
- HYPRE_StructStencilCreate
Create a stencil object for the specified number of spatial dimensions
and stencil entries
- HYPRE_StructStencilDestroy
Destroy a stencil object
- HYPRE_StructStencilSetElement
Set a stencil entry
- HYPRE_StructVectorAddToBoxValues
Set vector coefficients a box at a time
- HYPRE_StructVectorAddToValues
Set vector coefficients index by index
- HYPRE_StructVectorAssemble
Finalize the construction of the vector before using
- HYPRE_StructVectorCreate
Create a vector object
- HYPRE_StructVectorDestroy
Destroy a vector object
- HYPRE_StructVectorGetBoxValues
Get vector coefficients a box at a time
- HYPRE_StructVectorGetValues
Get vector coefficients index by index
- HYPRE_StructVectorInitialize
Prepare a vector object for setting coefficient values
- HYPRE_StructVectorPrint
Print the vector to file
- HYPRE_StructVectorSetBoxValues
Set vector coefficients a box at a time
- HYPRE_StructVectorSetValues
Set vector coefficients index by index
- initComplete
This function signals to the FEI that the initialization step has
been completed
- initCRMult
This function initializes the Lagrange multiplier constraints
- initElem
This function initializes element connectivity (that is, the node
identifiers associated with the current element) given an element
block identifier and the element identifier with the element block
- initElemBlock
The whole finite element mesh can be broken down into a number of
element blocks
- initFields
Each node or element variable has one or more fields
- initSharedNodes
This function initializes the nodes that are shared between the
current processor and its neighbors
- LLNL_FEI_Fei
Finite element interface constructor: this function creates an
instantiation or object of the fei class
- loadComplete
This function signals to the FEI that the loading phase has
been completed
- loadCRMult
This function loads the Lagrange multiplier constraints
- loadNodeBCs
This function loads the nodal boundary conditions
- parameters
The parameter function is the single most important function
to pass solver information (which solver, which preconditioner,
tolerance, other solver parameters) to HYPRE
- resetInitialGuess
This function resets the solution vector to s
- resetMatrix
This function resets the global matrix to be of the same sparsity
pattern as before but with every entry set to s
- resetRHSVector
This function resets the right hand side vector to s
- resetSystem
This function resets the global matrix to be of the same sparsity
pattern as before but with every entry set to s
- sumInElem
This function adds the element contribution to the global stiffness matrix
and also the element load to the right hand side vector
- sumInElemMatrix
This function differs from the sumInElem function in that the right hand
load vector is not passed
- sumInElemRHS
This function adds the element load to the right hand side vector
- ~LLNL_FEI_Fei
Finite element interface destructor: this function destroys
the object as well as its internal memory allocations
Macros
hierarchy of classes
generated by doc++