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