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