▼ 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
► 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 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
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 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