Anasazi | |
MultiVecTraits< double, NOX::Abstract::MultiVector > | Implementation of the Anasazi::MultiVecTraits for NOX::Abstract::MultiVectors |
OperatorTraits< double, NOX::Abstract::MultiVector, LOCA::AnasaziOperator::AbstractStrategy > | Implementation of the Anasazi::OperatorTraits for LOCA operators |
LOCASort | An implementation of the Anasazi::SortManager that performs a collection of common sorting techniques |
LOCA | |
Abstract | LOCA abstract interface namespace |
Factory | Abstract interface for providing a user-defined factory |
Group | Compatiblity class for AbstractGroup hierarchy |
Iterator | An abstract interface for implementing iteration |
TransposeSolveGroup | Abstract group interface class for solving the transpose of the Jacobian |
AnasaziOperator | Various group based operators for computing eigenvalues with Anasazi |
AbstractStrategy | Abstract interface class for Anasazi operator strategies |
Cayley | Anasazi operator for computing generalized eigenvalues using Cayley transformations |
Cayley2Matrix | Anasazi operator for computing generalized eigenvalues using Cayley transformations |
Factory | Factory for creating Anasazi operator strategy objects |
JacobianInverse | Anasazi operator for computing eigenvalues of the inverse-Jacobian |
ShiftInvert | Anasazi operator for computing generalized eigenvalues using shift-invert |
ShiftInvert2Matrix | Anasazi operator for computing generalized eigenvalues using shift-invert |
Bifurcation | |
PitchforkBord | |
StatusTest | Convergence tests relating to pitchfork groups |
NullVectorNormWRMS | A convergence test based on the weighted root-mean-square norm of the update to the null vector component for pitchfork location |
ParameterUpdateNorm | A convergence test based on the update of the parameter component for pitchfork location |
SlackUpdateNorm | A convergence test based on the update of the slack variable component for pitchfork location |
TPBord | |
StatusTest | Convergence tests relating to turning point groups |
NullVectorNormWRMS | A convergence test based on the weighted root-mean-square norm of the update to the null vector component for turning point location |
ParameterUpdateNorm | A convergence test based on the update of the parameter component for turning point location |
Factory | Factory for creating bifurcation strategy objects |
BorderedSolver | Strategies for solving bordered systems of equations |
AbstractOperator | Abstract interface class representing an operator for solving bordered sets of linear equations |
AbstractStrategy | Abstract interface class for solving bordered sets of linear equations |
BorderedOperator | Bordered solver operator representing as bordered Jacobian as operator as implemented in the NOX::Abstract::Group |
Bordering | Bordered system solver strategy based on bordering |
ComplexOperator | Bordered solver operator representing the as implemented in the LOCA::Hopf::MooreSpence::AbstractGroup |
Factory | Factory for creating BorderedSolver strategy objects |
HouseholderQR | A convenience class to compute the QR factorization of a an extended multi-vector |
JacobianOperator | Bordered solver operator representing the Jacobian as implemented in the NOX::Abstract::Group |
LowerTriangularBlockElimination | Block elimination strategy for solving a block lower-triangular system |
Nested | Bordered system solver strategy for nested bordered systems |
UpperTriangularBlockElimination | Block elimination strategy for solving a block upper-triangular system |
EpetraAugmented | Bordered system solver strategy based on augmenting the Jacobian operator |
EpetraHouseholder | Bordered system solver strategy based on Householder transformations |
LAPACKDirectSolve | Bordered system solver strategy based on direct factorization |
BorderedSystem | |
AbstractGroup | An interface for groups that are bordered systems |
Continuation | |
StatusTest | Convergence tests relating to continuation groups |
ParameterResidualNorm | A convergence test based on the parameter component of the residual for continuation |
ParameterUpdateNorm | A convergence test based on the update of the parameter component for continuation |
Eigensolver | Collection of eigensolver strategies |
AbstractStrategy | Abstract interface class for Eigensolver strategies |
AnasaziStrategy | Anasazi eigensolver strategy |
DefaultStrategy | Default eigensolver strategy |
Factory | Factory for creating Eigensolver strategy objects |
DGGEVStrategy | LAPACK DGGEV eigensolver strategy |
EigenvalueSort | Collection of eigenvalue sorting strategies |
Factory | Factory for creating EigenvalueSort strategy objects |
AbstractStrategy | Abstract interface for eigenvalue sorting strategies |
LargestMagnitude | Largest-magnitude sorting strategy |
SmallestMagnitude | Smallest-magnitude sorting strategy |
LargestReal | Largest-real sorting strategy |
SmallestReal | Smallest-real sorting strategy |
LargestImaginary | Largest-imaginary sorting strategy |
SmallestImaginary | Smallest-imaginary sorting strategy |
LargestRealInverseCayley | Largest-Real Cayley sorting strategy |
Epetra | LOCA Epetra support |
AnasaziOperator | |
Floquet | Anasazi operator for computing generalized eigenvalues using Cayley transformations |
Interface | Provides a set of interfaces for users to provide information about the nonlinear problem to LOCA |
FreeEnergy | Used by LOCA::Epetra::Group to provide a link to the external code for computing the free energy |
MassMatrix | Used by LOCA::Epetra::Group to provide a link to the external code for the MassMatrix (coefficients of time dependent terms) |
Required | Used by LOCA::Epetra::Group to provide a link to the external code for setting problem parameters |
TimeDependent | Used by LOCA::Epetra::Group to provide a link to the external code for computing the shifted matrix |
TimeDependentMatrixFree | Used by LOCA::Epetra::Group to provide a link to the external code for applying the shifted matrix in a matrix-free setting |
TransposeLinearSystem | Strategies for solving transpose linear systems |
AbstractStrategy | A pure virtual interface for solving the transpose of a linear system |
ExplicitTranspose | Method for solving the transpose of a linear system by explicitly forming the transpose of the matrix |
Factory | Factory for creating transpose linear system strategy objects |
LeftPreconditioning | Method for solving the transpose of a linear system by transposing the preconditioner and switching to left preconditioning |
TransposePreconditioner | Method for solving the transpose of a linear system by using the transpose of the preconditioner |
AdaptiveSolutionManager | |
AdaptiveStepper | Implementation of LOCA::Abstract::Iterator for computing points along a continuation curve |
AugmentedOp | Epetra operator representing a bordered matrix |
CompactWYOp | An Epetra operator for solving extended sets of equations using Householder transformations |
Factory | Implementation of the LOCA::Abstract::Factory for Epetra groups |
Group | Extension of the NOX::Epetra::Group to LOCA |
IdentityOp | An Epetra operator representing the identity matrix |
LeftPreconditionedOp | An Epetra operator for implementing the operator |
LowRankUpdateOp | An Epetra operator for implementing the operator |
LowRankUpdateRowMatrix | An Epetra row matrix for implementing the operator |
ModelEvaluatorInterface | Wrapper for an EpetraExt::ModelEvaluator |
ShiftInvertInterface | Interface for LOCA::Epetra::ShifterInvertOperator |
ShiftInvertOperator | Epetra operator for |
xyztPrec | Preconditioner operator class for solving space-time (XYZT) systems |
Extended | Extended groups and vectors |
MultiAbstractGroup | LOCA abstract interface for extended groups, derived from the NOX::Abstract::Group, i.e., an abstract interface for "super" groups that have an underlying group component |
MultiVector | Implemenatation of the NOX::Abstract::MultiVector class for extended multi-vectors comprised of an arbitrary number of multi-vectors and scalars |
Vector | Implemenatation of the NOX::Abstract::Vector class for extended vectors comprised of an arbitrary number of vectors and scalars |
Homotopy | |
AbstractGroup | Interface to underlying groups for homotopy calculations |
DeflatedGroup | LOCA's Homotopy Algorithm |
Group | LOCA's Homotopy Algorithm |
Hopf | Groups and vectors for Hopf bifurcations |
MinimallyAugmented | Groups and vectors for locating Hopf bifurcations using the minimally augmented Hopf formulation |
AbstractGroup | Interface to underlying groups for Hopf calculations using the minimally augmented formulation |
Constraint | Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing Hopf bifurcations for the minimally augmented Hopf formulation |
ExtendedGroup | A group representing the minimally augemented Hopf equations |
FiniteDifferenceGroup | Concrete class that provides concrete implementations of the derivative computation methods of the LOCA::Hopf::MinimallyAugmented::AbstractGroup using first-order finite differencing |
MooreSpence | Groups and vectors for locating Hopf bifurcations using the Moore-Spence formulation |
AbstractGroup | Interface to underlying groups for Hopf point calculations using the Moore-Spence formulation |
ExtendedGroup | A group representing the Moore-Spence Hopf equations |
ExtendedMultiVector | Multi-vector class to hold solution vectors, Newton vectors, etc.for the Moore-Spence Hopf eqautions |
ExtendedVector | Vector class to hold solution vectors, Newton vectors, etc. for Moore-Spence Hopf equations |
FiniteDifferenceGroup | Concrete class that provides concrete implementations of the derivative computation methods of the LOCA::Hopf::MooreSpence::AbstractGroup using first-order finite differencing |
SalingerBordering | Moore-Spence Hopf solver strategy based on "Salinger" bordering. This is the classic 5-solve Hopf bordering method |
SolverFactory | Factory for creating solver objects for solving Moore-Spence Hopf equations |
SolverStrategy | Abstract strategy for solving the Moore-Spence Hopf equations |
ComplexMultiVector | Multi-vector class to hold two multi-vectors to represent a complex multi-vector |
ComplexVector | Vector class to hold two vectors to represent a complex vector |
LAPACK | LOCA BLAS/LAPACK support |
Factory | Implementation of the LOCA::Abstract::Factory for LAPACK groups |
Group | Extension of the NOX::LAPACK::Group to LOCA |
Interface | Virtual interface for LOCA::LAPACK::Group to provide a link to the external code for RHS and Jacobian fills |
MultiContinuation | Groups and vectors for multi-parameter continuation |
AbstractGroup | LOCA abstract interface for continuation, derived from the NOX::Abstract::Group. This abstract class provides the interface necessary to perform continuation, i.e., compute families of solutions to |
AbstractStrategy | Abstract interface class for continuation strategies |
ArcLengthConstraint | Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for arclength continuation |
ArcLengthGroup | Specialization of LOCA::MultiContinuation::ExtendedGroup to pseudo-arclength continuation |
CompositeConstraint | Implementation of LOCA::MultiContinuation::ConstraintInterface for composite constraints, i.e., a constraint comprised of multiple, separate constraints |
CompositeConstraintMVDX | Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for composite constraints, i.e., a constraint comprised of multiple, separate constraints |
ConstrainedGroup | Extended group representing a constrained nonlinear problem |
ConstraintInterface | Abstract interface for the constraint portion of a constrained nonlinear system |
ConstraintInterfaceMVDX | Abstract interface for the constraint portion of a constrained nonlinear system for constraints that support computing a solution component derivative as a multi-vector |
ExtendedGroup | Base class for all continuation groups |
ExtendedMultiVector | MultiVector class to hold solution vectors, Newton vectors, etc. for continuation equations |
ExtendedVector | Vector class to hold solution vectors, Newton vectors, etc. for continuation equations |
Factory | Factory for creating continuation strategy objects |
FiniteDifferenceGroup | Concrete class that provides a concrete implementation of the computeDfDp() method of the LOCA::Continuation::AbstractGroup using first-order finite differencing |
MultiVecConstraint | Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for a simple linear multivector constraint |
NaturalConstraint | Implementation of LOCA::MultiContinuation::ConstraintInterface for natural continuation |
NaturalGroup | Specialization of LOCA::MultiContinuation::ExtendedGroup to natural continuation |
MultiPredictor | Predictor direction strategies |
AbstractStrategy | Abstract interface class for predictor strategies |
Constant | Constant predictor strategy |
Factory | Factory for creating Predictor strategy objects |
Random | Random predictor strategy |
Restart | Restart predictor strategy |
Secant | Secant predictor strategy |
Tangent | Tangent predictor strategy |
Parameter | |
AbstractEntry | Abstract interface for all entries in LOCA::Parameter::Library |
Entry | Parameter entry interface class templated on ValueType |
StandardEntry | Standard parameter entry class using a function object |
DefaultFunctor | Default function object for setting a single parameter in a single object using a data member pointer |
Library | Class to provide a centralized library for setting/retrieving numerical parameter values in application codes |
SublistParser | Class to parse a parameter list for sublists |
PhaseTransition | Groups and vectors for turning point bifurcations |
AbstractGroup | Interface to underlying groups for phase transition calculations |
ExtendedGroup | |
ExtendedMultiVector | MultiVector class to hold solution vectors, Newton vectors, etc. for the phase transition tracking algorithm |
ExtendedVector | Vector class to hold solution vectors, Newton vectors, etc. for the Phase Transition tracking formulation |
Pitchfork | Groups and vectors for pitchfork bifurcations |
MinimallyAugmented | Groups and vectors for locating pitchfork bifurcations using the minimally augmented turning point formulation |
AbstractGroup | Interface to underlying groups for pitchfork calculations using the minimally augmented formulation |
Constraint | Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing pitchforks for the minimally augmented pitchfork formulation |
ExtendedGroup | A group representing the minimally augemented pitchfork equations |
MooreSpence | Groups and vectors for locating pitchfork bifurcations using the Moore-Spence formulation |
AbstractGroup | Interface to underlying groups for pitchfork calculations using the Moore-Spence formulation |
ExtendedGroup | A group representing the Moore-Spence pitchfork equations |
ExtendedMultiVector | MultiVector class to hold solution vectors, Newton vectors, etc.for the Moore-Spence pitchfork formulation |
ExtendedVector | Vector class to hold solution vectors, Newton vectors, etc. for the Moore-Spence turning point formulation |
PhippsBordering | Moore-Spence pitchfork solver strategy based on "Phipps" bordering which is the 7-solve modified pitchfork bordering algorithm that uses bordered linear solves |
SalingerBordering | Moore-Spence pitchfork solver strategy based on "Salinger" bordering. This is the classic 6-solve bordering method |
SolverFactory | Factory for creating solver objects for solving Moore-Spence pitchfork equations |
SolverStrategy | Abstract strategy for solving the Moore-Spence pitchfork equations |
SaveEigenData | Collection strategies to save eigenvector/value data |
AbstractStrategy | Abstract interface class strategies to save eigenvector/value data |
DefaultStrategy | Default strategy for saving eigenvector/value data |
Factory | Factory for creating strategy objects to save eigenvectors/values |
SingularJacobianSolve | Strategies for solving when is (nearly) singular |
Default | Default singular Jacobian solve computation class |
Generic | Generic singular jacobian solve interface |
ItRef | This class computes the solution to using one step of iterative refinement |
Manager | Manager for all singular Jacobian solve computations |
Nic | This class computes the solution to using the Nic method |
NicDay | This class computes the solution to using the Nic-Day method |
Solver | LOCA Solver classes |
Wrapper | A wrapper class for wrapping a NOX solver |
StatusTest | Status checkers |
Abstract | |
Combo | Arbitrary combination of status tests |
Factory | Factory to build a set of status tests from a parameter list |
MaxIters | Failure test based on the maximum number of continuation steps |
Wrapper | A wrapper class for wrapping a NOX status test |
StepSize | Collection of step size control strategies |
AbstractStrategy | Abstract interface class for step size control strategies |
Adaptive | Adaptive step size control strategy |
Constant | Constant step size control strategy |
Factory | Factory for creating step size control strategy objects |
Thyra | LOCA Thyra support |
Group | Extension of the NOX::Thyra::Group to LOCA |
GroupWrapper | Extension of the LOCA::Thyra::Group to provide access to solution data |
SaveDataStrategy | Abstract interface class strategies to save continuation data |
TimeDependent | |
AbstractGroup | Interface to underlying groups for time dependent systems |
TurningPoint | Groups and vectors for turning point bifurcations |
MinimallyAugmented | Groups and vectors for locating turning point bifurcations using the minimally augmented turning point formulation |
AbstractGroup | Interface to underlying groups for turning point calculations using the minimally augmented formulation |
Constraint | Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing turning points for the minimally augmented turning point formulation |
ExtendedGroup | A group representing the minimally augemented turning point equations |
FiniteDifferenceGroup | Concrete class that provides concrete implementations of the derivative computation methods of the LOCA::TurningPoint::MinimallyAugmented::AbstractGroup using first-order finite differencing |
ModifiedConstraint | Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing turning points for the minimally augmented turning point formulation |
MooreSpence | Groups and vectors for locating turning point bifurcations using the Moore-Spence formulation |
AbstractGroup | Interface to underlying groups for turning point calculations using the Moore-Spence formulation |
ExtendedGroup | A group representing the Moore-Spence turning point equations |
ExtendedMultiVector | MultiVector class to hold solution vectors, Newton vectors, etc.for the Moore-Spence turning point formulation |
ExtendedVector | Vector class to hold solution vectors, Newton vectors, etc. for the Moore-Spence turning point formulation |
FiniteDifferenceGroup | Concrete class that provides concrete implementations of the derivative computation methods of the LOCA::TurningPoint::MooreSpence::AbstractGroup using first-order finite differencing |
PhippsBordering | Moore-Spence turning point solver strategy based on "Phipps" bordering which is the 5-solve modified turning point bordering algorithm that uses bordered linear solves |
SalingerBordering | Moore-Spence turning point solver strategy based on "Salinger" bordering. This is the classic 4-solve bordering method |
SolverFactory | Factory for creating solver objects for solving Moore-Spence turning point equations |
SolverStrategy | Abstract strategy for solving the Moore-Spence turning point equations |
DerivUtils | LOCA's generic derivative computation class to compute various derivatives via finite differencing |
ErrorCheck | An Error checking algorithm for NOX/LOCA routines |
Factory | Factory class for creating strategies |
GlobalData | Container class to hold "global" LOCA objects |
ParameterVector | LOCA's container for holding a set of parameters that are used by the LOCA continuation routines |
Stepper | Implementation of LOCA::Abstract::Iterator for computing points along a continuation curve |
MultiStepper | Implementation of LOCA::Abstract::Iterator for computing points along a continuation curve |
AdaptiveStepper | Implementation of LOCA::Abstract::Iterator for computing points along a continuation curve |
nox | |
MatrixFreeModelEvaluatorDecorator | Model Evaluator Decorator class that adds support for the evaluation of a matrix-free W_op |
NOX | Nonlinear solvers package namespace |
Abstract | NOX abstract interface for vector and group |
Group | NOX pure abstract interface to a "group"; i.e., a solution vector and the corresponding F-vector, Jacobian matrix, gradient vector, and Newton vector |
ImplicitWeighting | A pure virtual interface for enabling/disabling any user defined implicit weighting of the concrete object |
MultiVector | Abstract interface for multi-vectors used by NOX |
Vector | NOX's pure abstract vector interface for vectors that are used by the nonlinear solver |
Direction | Search direction strategies |
Utils | |
InexactNewton | Inexact Newton Utilities |
Broyden | Broyden direction |
BroydenMemory | Utility class for NOX::Direction::Broyden method to manage the information stored in "limited" memory |
BroydenMemoryUnit | Utility class for NOX::Direction::Broyden::BroydenMemory |
Factory | Factory to build direction objects derived from NOX::Direction::Generic |
Generic | Generic direction interface |
Newton | Newton direction computation |
NonlinearCG | Calculates a search direction using the Nonlinear Conjugate Gradient method |
SteepestDescent | Calculates the steepest descent direction |
UserDefinedFactory | Pure virtual interface for users to supply their own direction objects |
UserDefinedFactoryT | Concrete instantiation of a NOX::Direction::UserDefinedFactory object that uses the base objects only for constuction |
Epetra | Improved version of the Epetra support class |
Interface | Provides a set of interfaces for users to provide information about the nonlinear problem to NOX |
Jacobian | Used by NOX::Epetra to provide a link to the external code for Jacobian fills |
Preconditioner | Used by NOX::Epetra to provide a link to the external code for Precondtioner fills |
Required | Supplies NOX with the set nonlinear equations |
AdaptiveSolutionManager | |
AdaptManager | |
BroydenOperator | A concrete implementation of a Broyden-type operator for NOX |
ReplacementInterface | |
FiniteDifference | Concrete implementation for creating an Epetra_RowMatrix Jacobian via finite differencing of the residual |
FiniteDifferenceColoring | Concrete implementation for creating an Epetra_RowMatrix Jacobian via finite differencing of the residual using coloring |
FiniteDifferenceColoringWithUpdate | Concrete implementation for creating an Epetra_RowMatrix Jacobian via finite differencing of the residual using coloring. This method assumes the existence of a valid parallel coloring of the columns of the Jacobian (aka from Isorropia) |
Group | Concrete implementation of NOX::Abstract::Group for Trilinos/Epetra |
LinearSystem | Pure virtual class interface for allowing different linear solvers to be used by the NOX::Epetra::Group |
LinearSystemAztecOO | Concrete implementation of NOX::Epetra::LinearSolver for AztecOO |
MatrixFree | Concrete implementation for creating an Epetra_Operator Jacobian based on the Matrix-Free Newton-Krylov method |
MultiVector | Implementation of NOX::Abstract::MultiVector for Epetra multi-vectors |
Observer | |
Scaling | Object to control scaling of vectors and linear systems |
Vector | Implementation of NOX::Abstract::Vector for Epetra vectors |
VectorSpace | Pure virtual base class for the vector space used by NOX::Epetra::Vectors |
VectorSpaceL2 | Concrete class for an L2 vector space |
VectorSpaceScaledL2 | Concrete class for a weighted L2 vector space |
Exceptions | |
SolverFailure | A generic exception class denoting a solver failure |
LAPACK | NOX BLAS/LAPACK support |
Group | A simple example of a group structure, based on BLAS/LAPACK |
Matrix | A simple square matrix class for use by NOX::LAPACK::Group |
Interface | Virtual interface for NOX::BLAS::Group to provide a link to the external code for RHS and Jacobian fills |
LinearSolver | A simple linear solver for use by NOX::LAPACK::Group |
Vector | Implementation of NOX::Abstract::Vector for STL std::vector<double> (using LAPACK for some computations) |
LineSearch | NOX linesearches |
Utils | |
Printing | Common line search utilites for printing line search information to the screen |
Slope | Common line search utilites for computing the slope of a function |
Backtrack | Generic backtracking line search |
Factory | Factory to build line search objects derived from NOX::LineSearch::Generic |
FullStep | Simplest line search - always take the full step |
Generic | Base class line search interface |
MoreThuente | More'-Thuente Line Search. Original code by Dianne O'Leary, modfified by Tammy Kolda and Roger Pawlowski for the NOX project. This version has been slightly optimized and also supports Homer Walker's work on adaptive forcing terms and Ared/Pred conditions. It also allows for arbitrary merit functions and norms to be supplied by the user |
NonlinearCG | Use NonlinearCG linesearch |
Polynomial | A polynomial line search, either quadratic or cubic |
SafeguardedStep | A line search that determines the step size by capping the magnitue of specific entries of the direction vector. The limits are specified by a user defined vector |
UserDefinedFactory | Pure virtual interface for users to supply their own line search objects |
UserDefinedFactoryT | Concrete instantiation of a NOX::LineSearch::UserDefinedFactory object that uses the base objects only for constuction |
SafeguardedDirection | |
MeritFunction | |
Generic | Base class to support a user defined merit function that can be passed to line searches and directions through the parameter list |
SumOfSquares | Sum of squares merit function |
Multiphysics | |
DataExchange | |
Interface | Provides a set of interfaces for users to provide information about exchanging data between registered NOX solvers |
Solver | NOX nonlinear solvers namespace |
FixedPointBased | Nonlinear solver based on a line search (i.e., damping) |
Generic | Abstract nonlinear solver method interface |
Manager | Manager class to control the instantiation of the objects derived from the NOX::Solver::Generic object |
Group | NOX pure abstract interface to a "group"; i.e., a solution vector and the corresponding F-vector, Jacobian matrix, gradient vector, and Newton vector |
Petsc | NOX Petsc support |
Group | Concrete implementation of NOX::Abstract::Group for Petsc |
Interface | Used by NOX::Petsc::Group to provide a link to the external code for F and Jacobian evaluations (if needed) |
Options | Class to convert solver options from command line (or command input file) into a form usable by NOX |
SharedJacobian | Shared Jacobian for NOX::Petsc::Group objects |
Vector | Implementation of NOX::Abstract::Vector for Petsc vectors |
Solver | NOX nonlinear solvers namespace |
AndersonAcceleration | Nonlinear solver based on Anderson Acceleration |
Factory | Factory class to control the creation of solvers derived from the NOX::Solver::Generic object |
Generic | Abstract nonlinear solver method interface |
InexactTrustRegionBased | Newton-like solver using a trust region |
LineSearchBased | Nonlinear solver based on a line search (i.e., damping) |
SingleStep | Light wrapper over linear solver, executes exactly one iteration |
TensorBased | Nonlinear solver based on a rank-1 tensor method |
TrustRegionBased | Newton-like solver using a trust region |
PseudoTransient | Pseudo-transient solver |
StatusTest | Status checkers |
Combo | Arbitrary combination of status tests |
Divergence | Failure test based on a threshold value of the norm of F |
Factory | Factory to build a set of status tests from a parameter list |
FiniteValue | Failure test based on whether the norm of a vector has a finite value |
Generic | Generic status test to check for convergence or failure of the nonlinear solver |
MaxIters | Failure test based on the maximum number of nonlinear solver iterations |
NormF | Various convergence tests based on the norm of the residual |
NormUpdate | Various convergence tests based on the norm of the change in the solution vector, , between outer iterations |
NormWRMS | Convergence test based on the weighted root mean square norm fo the solution update between iterations |
NStep | Takes n Iterations before declaring convergence |
RelativeNormF | Requires reduction in residual norm compared to initial norm |
Stagnation | Failure test based on the convergence rate between nonlinear iterations |
Thyra | NOX Thyra support |
WeightedMeritFunction | Implementation of merit function for implicitly weighted norm |
Group | A concrete implementation of the NOX::Abstract::Group using Thyra |
MatrixFreeJacobianOperator | Concrete implementation of a Thyra::LinearOpBase object that approximates a Jacobian operator based on the Jacobian-Free Newton-Krylov method (see Knoll and Keyes Journal of Computational Physics 193 (2004) 357-397 for details) |
MultiVector | Implementation of NOX::Abstract::MultiVector for Thyra multi-vectors |
Vector | Implementation of NOX::Thyra::Vector |
GlobalData | Container class to hold "global" NOX objects |
LineSearchCounters | Common counters that all line search algorithms should report |
MultiVector | Default implementation for NOX::Abstract::MultiVector using an array of NOX::Abstract::MultiVector's |
Observer | NOX's pure virtual class to allow users to insert user defined operations into nox's solvers (before and after the NOX::Solver::Generic::step() and NOX::Solver::Generic::solve() methods). This is an Observer from GoF design pattern book |
ObserverLog | Logs observer calls. Useful for unit testing and debugging |
ObserverPrint | A NOX::Observer that provides summary solver output |
ObserverVector | Concrete implementation of NOX::Observer that stores a vector of Observers |
Random | A class to compute uniformly distributed random numbers in (-1,1) |
SharedObject | Holder for objects that are shared between NOX::Abstract::Groups |
SolverStats | Container for solver statistics |
LinearSolveStats | Statistics for the linear solve |
TrustRegionStats | Container for trust region statistics |
Utils | Provides printing utilities |
Fill | Fill object - used to print the given character the number of times specified |
Sci | Sci object - used to print the given value with the specified precision |
MatrixFreeModelEvaluatorDecorator | Model Evaluator Decorator class that adds support for the evaluation of a matrix-free W_op |
RowSumScaling | Updates an inverse row sum scaling vector at the beginning of a solve |
RTOpPack | |
TOpEleWiseMinSwapEleWiseTransformation | Element-wise transformation operator for TOpEleWiseMinSwap |
TOpEleWiseMinSwap | Element-wise product update transformation operator: z0[i] *= min(v0[i],abs(z0[i]) * z0[i]/abs(z0[i]), i=0...n-1 |
Thyra | |
AdaptiveStateBase | |
LOCAAdaptiveState | |
TransAdaptiveState | |
AdaptiveSolutionManager | |
VectorBase | |
ModelEvaluator | |
MultiVectorBase | |
LinearOpBase | |
LinearOpWithSolveBase | |
LinearOpWithSolveFactoryBase | |
DefaultLinearOpSource | |
PreconditionerFactoryBase | |
PreconditionerBase | |
NOXNonlinearSolver | Concrete nonlinear solver for NOX |
Trilinos | |
Details | |
ContinuationManager | |
LOCAData | |
LOCAInterface | |
LOCANVectorData | |
ParamData | |
ProblemLOCAPrototype | |
ProblemNOXPrototype | |