![o](ftv2pnode.png) Teuchos::AbstractFactory< BasisSystem > [external] | |
![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::BasisSystemFactory | Interface for a factory object that will create BasisSystem objects |
![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::BasisSystemFactoryStd | Default implementation for BasisSystemPermDirectSparse obejcts using DirectSparseSolver object |
![o](ftv2pnode.png) Teuchos::AbstractFactory< VectorMutable > [external] | |
![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::VectorSpace | Abstract interface for objects that represent a space for mutable coordinate vectors |
![|](ftv2vertline.png) ![](ftv2blank.png) ![o](ftv2node.png) AbstractLinAlgPack::VectorSpaceBlocked | VectorSpace subclass for the composite of one or more VectorSpace objects |
![|](ftv2vertline.png) ![](ftv2blank.png) ![o](ftv2node.png) AbstractLinAlgPack::VectorSpaceSerial | Subclass for serial vector space objects that create VectorMutableDense vector and MultiVectorMutableDense multi-vector objects |
![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::VectorSpaceSubSpace | Concrete subclass for a default sub-space of a vector |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolverDense::BasisMatrixDense | Implements the BasisMatrix object for Dense |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolverMA28::BasisMatrixMA28 | Implements the BasisMatrix object for MA28 |
![o](ftv2pnode.png) AbstractLinAlgPack::BasisSystem | Interface for the creation and maintainance of a basis matrix for a decomposition of linearlized constriants |
![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::BasisSystemComposite | Simple BasisSystem subclass the case where the client sets up seperate C and N matrices |
![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::BasisSystemPerm | Interface for setting and selecting a basis from the Jacobian from a set of equations |
![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::BasisSystemPermDirectSparse | Permutatble basis system subclass that uses a direct sparse solver |
![o](ftv2node.png) AbstractLinAlgPack::BasisSystemTester | Testing class for BasisSystem interface |
![o](ftv2node.png) AbstractLinAlgPack::compare_element_indexes_equal_to< T_Element > | Ele.index() == i |
![o](ftv2node.png) AbstractLinAlgPack::compare_element_indexes_less< T_Element > | Ele1.index() < ele2.index() |
![o](ftv2node.png) AbstractLinAlgPack::COOMatrix | Sparse Coordinate Matrix abstraction storage class |
![o](ftv2node.png) AbstractLinAlgPack::COOMatrixPartitionedView< T_Indice, T_Value > | COO Matrix partitioning view class |
![o](ftv2node.png) AbstractLinAlgPack::COOMatrixPartitionedView< indice_type, value_type > | |
![o](ftv2node.png) AbstractLinAlgPack::COOMatrixWithPartitionedView | Aggregation of a COO matrix and a partitioned view of it |
![o](ftv2pnode.png) AbstractLinAlgPack::DirectSparseSolver | Abstract interface to serial direct sparse linear solvers |
![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::DirectSparseSolverImp | Implementation node class for DirectSparseSolver that takes care of the memory management details |
![|](ftv2vertline.png) ![](ftv2blank.png) ![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolverDense | Concreate sparse solver subclass that uses the dense LAPACK routines |
![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::DirectSparseSolverMA28 | Concreate sparse solver subclass that uses MA28 |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::DoesNotExistException | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::DuplicateIndexesException | |
![o](ftv2node.png) AbstractLinAlgPack::TransSparseCOOElementViewIter< T_Iter, T_IterCat, T_Indice, T_ValRef, T_Diff >::ElementView< TT_Iter, TT_IterCat, TT_Indice, TT_ValRef, TT_Diff > | Type for the object that is returned for the transpose sparse element |
![o](ftv2node.png) AbstractLinAlgPack::TransSparseCOOElementViewIter< T_Iter, T_IterCat, T_Indice, T_ValRef, T_Diff >::ElementView< T_Iter, T_IterCat, T_Indice, T_ValRef, T_Diff > | |
![o](ftv2node.png) AbstractLinAlgPack::EtaVector | Create an eta vector (scaled by alpha = default 1) |
![o](ftv2node.png) AbstractLinAlgPack::GenPermMatrixSliceIteratorPack::external_row_col_value_type< T > | External storage of a row and column indice. This is required for creating a temporary in an assignment operation in a sorting algorithm (like std::sort(...)) |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolver::FactorizationFailure | |
![o](ftv2pnode.png) AbstractLinAlgPack::DirectSparseSolverImp::FactorizationNonzeros | Abstract class for objects that represent the factorization nonzeros of a particular matrix |
![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolverDense::FactorizationNonzerosDense | Stores the factorization nonzeros for Dense |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::DirectSparseSolverMA28::FactorizationNonzerosMA28 | Stores the factorization nonzeros for MA28 |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolver::FactorizationStructure | Abstract class for objects that represent the factorization structure of a particular matrix |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolverDense::FactorizationStructureDense | Stores the factorization structure for Dense |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolverMA28::FactorizationStructureMA28 | Stores the factorization structure for MA28 |
![o](ftv2node.png) AbstractLinAlgPack::GenPermMatrixSlice | Concrete matrix type to represent general permutation (mapping) matrices |
![o](ftv2node.png) AbstractLinAlgPack::MatrixBase::IncompatibleMatrices | Thrown if matrices are incompatible |
![o](ftv2node.png) AbstractLinAlgPack::MatrixOp::IncompatibleMatrices | Thrown if matrices are not compatible |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolver::IncompatibleMatrixStructureException | |
![o](ftv2node.png) AbstractLinAlgPack::VectorSpace::IncompatibleVectorSpaces | Thrown if vector spaces are incompatible |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymAddDelUpdateable::Inertia | Struct for the inertia of the matrix |
![o](ftv2pnode.png) AbstractLinAlgPack::InnerProduct | Abstract interface for inner products |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::InnerProductDot | Implements the inner product as the dot product |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::SpVecIndexLookup< T_Element >::InvalidInternalStateException | |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolver::InvalidObjectType | |
![o](ftv2node.png) MA28_Cpp::MA28Solver | MA28 Basic Encapsulation Class |
![o](ftv2node.png) AbstractLinAlgPack::MatrixOp::MatNorm | Returned form calc_norm() |
![o](ftv2pnode.png) AbstractLinAlgPack::MatrixBase | Base class for all polymorphic matrices |
![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixConvertToSparse | Mix-in interface for extracing explicit elements from a sparse matrix in one of several Fortran compatible formats |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixConvertToSparseEncap | Sparse conversion subclass based on views of a MatrixExtractSparseElements object |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixExtractSparseElements | Interface for extracting nonzero elements from a banded subregion of a permuted sparse matrix in one of several Fortran compatible formats |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSparseCOORSerial | Coordinate matrix subclass |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::MatrixSymDiagSparse | Abstract base class for all serial symmetric diagonal matrices with significant zeros along the diagonal |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymDiagSparseStd | Concrete subclass for a serial symmetric diagonal matrix with many zeros on the diagonal |
![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixExtractInvCholFactor | Mix-in Interface for extracting the inverse cholesky factor of a dense symmetric positive definite matrix |
![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixLoadSparseElements | Mix-in interface for loading nonzero elements into a sparse matrix data structure |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSparseCOORSerial | Coordinate matrix subclass |
![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixNonsing | Abstract base class for all nonsingular polymorphic matrices that can solve for linear system with but it may not be convienent to compute matrix vector products {abstract} |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::DirectSparseSolver::BasisMatrix | Abstract class for objects that represent the factorized matrix and can be used to solve for different right-hand-sides |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::DirectSparseSolverImp::BasisMatrixImp | Implementation node subclass that combines factorization structure and factorization nonzeros into a single basis matrix object |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixNonsingSerial | Abstract base class for all AbstractLinAlgPack::MatrixNonsing objects implemented in shared memory space |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpNonsingSerial | Abstract base class for all serial nonsingular polymorphic matrices that can be used to compute matrix-vector products and solve for linear systems efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::MatrixSymNonsingSerial | Abstract base class for all serial polymorphic symmetrix nonsingular matrices that can be used to solve for linear systems relatively efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymOpNonsingSerial | Abstract base class for all serial polymorphic symmetric nonsingular matrices that can be used to compute matrix-vector products and solve for linear systems relatively efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixOpNonsing | Abstract base class for all nonsingular polymorphic matrices that can be used to compute matrix-vector products and solve for linear systems efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpNonsingAggr | Aggregate matrix class pulling together a MatrixOp object and a MatrixNonsing object into a unified matrix object |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpNonsingSerial | Abstract base class for all serial nonsingular polymorphic matrices that can be used to compute matrix-vector products and solve for linear systems efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixSymOpNonsing | Abstract base class for all polymorphic symmetrix nonsingular matrices that can be used to compute matrix-vector products and solve for linear systems relatively efficently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixSymDiag | Interface to all diagonal matrices {abstract} |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymDiagStd | Simple diagonal matrix class |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixSymIdent | Matrix subclass for a scaled identity matrix |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymOpNonsingSerial | Abstract base class for all serial polymorphic symmetric nonsingular matrices that can be used to compute matrix-vector products and solve for linear systems relatively efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymOpNonsingSerial | Abstract base class for all serial polymorphic symmetric nonsingular matrices that can be used to compute matrix-vector products and solve for linear systems relatively efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::MatrixSymNonsing | Abstract base class for all polymorphic symmetrix nonsingular matrices that can be used to solve for linear systems relatively efficently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![](ftv2blank.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixSymNonsingSerial | Abstract base class for all serial polymorphic symmetrix nonsingular matrices that can be used to solve for linear systems relatively efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymOpNonsing | Abstract base class for all polymorphic symmetrix nonsingular matrices that can be used to compute matrix-vector products and solve for linear systems relatively efficently |
![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixOp | Base class for all matrices that support basic matrix operations |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::COOMatrixPartitionViewSubclass | Implementation of MatrixOp abstract interface for COOMatrixWithPartitionedView::partition_type |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixComposite | Matrix class for matrices composed out of a set of other matrices and vectors |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixOpGetGMS | Abstract interface that allows the extraction of a const DMatrixSlice view of an abstract matrix |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpGetGMSMutable | Abstract interface that allows the extraction of a non-const DMatrixSlice view of an abstract matrix |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MultiVectorMutableDense | MultiVectorMutable "Adapter" subclass for DenseLinAlgPack::DMatrixSlice or DenseLinAlgPack::DMatrix object |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpGetGMSTri | Mix-in interface that allows the extraction of a const DenseLinAlgPack::DMatrixSliceTri view of an non-singular abstract matrix |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpNonsing | Abstract base class for all nonsingular polymorphic matrices that can be used to compute matrix-vector products and solve for linear systems efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixOpSerial | Base class for all matrices implemented in a shared memory address space |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpNonsingSerial | Abstract base class for all serial nonsingular polymorphic matrices that can be used to compute matrix-vector products and solve for linear systems efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixSymOpSerial | Abstract base class for all AbstractLinAlgPack::MatrixSymOp objects implemented in shared memory space |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixSymDiagSparse | Abstract base class for all serial symmetric diagonal matrices with significant zeros along the diagonal |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymOpNonsingSerial | Abstract base class for all serial polymorphic symmetric nonsingular matrices that can be used to compute matrix-vector products and solve for linear systems relatively efficiently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MultiVectorMutableDense | MultiVectorMutable "Adapter" subclass for DenseLinAlgPack::DMatrixSlice or DenseLinAlgPack::DMatrix object |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixOpSubView | Standard subclass for representing a sub, possibly transposed, view of a matrix |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixPermAggr | Aggregate matrix class for a matrix and its permuted view |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixSparseCOORSerial | Coordinate matrix subclass |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixSymOp | Interface adding operations specific for a symmetric matrix {abstract} |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::MatrixSymOpGetGMSSym | Abstract interface that allows the extraction of a const DenseLinAlgPack::DMatrixSliceSym view of an abstract matrix |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymOpGetGMSSymMutable | Abstract interface that allows the extraction of a non-const DenseLinAlgPack::DMatrixSliceSym view of a symmetry abstract matrix |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixSymOpNonsing | Abstract base class for all polymorphic symmetrix nonsingular matrices that can be used to compute matrix-vector products and solve for linear systems relatively efficently |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymOpSerial | Abstract base class for all AbstractLinAlgPack::MatrixSymOp objects implemented in shared memory space |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixWithOpConcreteEncap< M > | This template class defines the storage for a concrete matrix class that operations are based on |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixZero | Implementation of a matrix with all zeros |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::MultiVector | Interface for a collection of non-mutable vectors (multi-vector, matrix) |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::MultiVectorMutable | Interface for a collection of mutable vectors (multi-vector, matrix) |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![](ftv2blank.png) ![](ftv2blank.png) ![o](ftv2node.png) AbstractLinAlgPack::MultiVectorMutableCols | Default subclass for MultiVectorMutable implemented using columns of separate abstract vectors |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![](ftv2blank.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MultiVectorMutableDense | MultiVectorMutable "Adapter" subclass for DenseLinAlgPack::DMatrixSlice or DenseLinAlgPack::DMatrix object |
![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixSymAddDelUpdateable | Mix-in Interface for updating a serial symmetric matrix by adding and deleting rows and columns |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymDenseInitialize | Mix-in Interface for initializing a matrix with a dense symmetric matrix |
![o](ftv2node.png) AbstractLinAlgPack::MatrixCOORTmplItfc< T_Scalar, T_Index > | Templated class that supports the COOMatrixTemplateInterface template interface |
![o](ftv2node.png) AbstractLinAlgPack::MatrixCOORTmplItfcItr< T_Scalar, T_Index > | Templated class for iterator returning objects that support the SparseCOOElementTemplatInterface specification |
![o](ftv2node.png) AbstractLinAlgPack::MatrixCOORTmplItfcItrEleView< T_Scalar, T_Index > | Templated class for objects that support the SparseCOOElementTemplatInterface specification |
![o](ftv2node.png) AbstractLinAlgPack::MatrixDenseEncap | Helper class type that simplifies the usage of the MatrixOpGetGMS interface for clients |
![o](ftv2node.png) AbstractLinAlgPack::MatrixDenseMutableEncap | Helper class type that simplifies the usage of the MatrixOpGetGMSMutable interface for clients |
![o](ftv2node.png) AbstractLinAlgPack::MatrixDenseSymEncap | Helper class type that simplifies the usage of the MatrixSymOpGetGMSSym interface for clients |
![o](ftv2node.png) AbstractLinAlgPack::MatrixDenseSymMutableEncap | Helper class type that simplifies the usage of the MatrixSymOpGetGMSSymMutable interface for clients |
![o](ftv2node.png) AbstractLinAlgPack::MatrixDenseTriEncap | Helper class type that simplifies the usage of the MatrixOpGetGMSTri interface for clients |
![o](ftv2node.png) AbstractLinAlgPack::MatrixOpNonsingTester | Testing class for MatrixOpNonsing interface |
![o](ftv2node.png) AbstractLinAlgPack::MatrixScaling_Strategy | Abstract interface for sparse matrix scaling strategies |
![o](ftv2pnode.png) AbstractLinAlgPack::MatrixSymInitDiag | Mix-in Interface for setting a matrix to a diagonal {abstract} |
![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::MatrixSymDiagStd | Simple diagonal matrix class |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymSecant | Mix-in interface for all polymorphic symmetric matrices that support secant updating |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymAddDelUpdateable::MaxSizeExceededException | Thrown if the maximum size is exceeded in augment_update(...) |
![o](ftv2node.png) AbstractLinAlgPack::MatrixOp::MethodNotImplemented | Thrown if a method is not implemented |
![o](ftv2node.png) AbstractLinAlgPack::NaNInfException | |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolver::NoCurrentBasisException | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::NoNonZeroElementsException | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::SpVecIndexLookup< T_Element >::NoSpVecSetException | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::NotSortedException | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::OutOfRoomException | |
![o](ftv2node.png) AbstractLinAlgPack::COOMatrixPartitionedViewUtilityPack::Partition< T_Indice, T_Value > | Class for a partition or a set of continous partitions in a partitioned COO matrix |
![o](ftv2node.png) AbstractLinAlgPack::Permutation | Abstract interface to permutation matrices |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymAddDelUpdateable::PivotTolerances | Struct for pivot tolerances to be used when initializing, and augmenting and deleting rows and columns |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::SpVecIndexLookup< T_Element >::poss_type | Struct with members: size_type poss; ElementRelation rel; |
![o](ftv2node.png) AbstractLinAlgPack::PostConditionException | Base class for postcondition exceptions |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymDiagStd::PostMod | PostMod class to use with MemMngPack::AbstractFactorStd |
![o](ftv2pnode.png) AbstractLinAlgPack::PreConditionException | Base class for precondition exceptions |
![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::InputException | Base class for input exceptions (Preconditions) |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::SetupException | Base class for invalid setup for a class object when an exception is thrown |
![o](ftv2pnode.png) MemMngPack::ReleaseResource [external] | |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSparseCOORSerial::ReleaseValRowColArrays | Subclass to delete dynamically allocated memory with delete [] |
![o](ftv2node.png) AbstractLinAlgPack::GenPermMatrixSliceIteratorPack::row_col_iterator< T > | This is a full random access iterator for accessing row and colunmn indices |
![o](ftv2node.png) AbstractLinAlgPack::GenPermMatrixSliceIteratorPack::row_col_value_type< T > | Internal storage for the iterator of the row and column indices |
![o](ftv2pnode.png) OptionsFromStreamPack::SetOptionsFromStream [external] | |
![|](ftv2vertline.png) ![\](ftv2plastnode.png) OptionsFromStreamPack::SetOptionsFromStreamNode [external] | |
![|](ftv2vertline.png) ![](ftv2blank.png) ![o](ftv2node.png) AbstractLinAlgPack::BasisSystemTesterSetOptions | Set options for BasisSystemTester from an OptionsFromStream object |
![|](ftv2vertline.png) ![](ftv2blank.png) ![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolverMA28SetOptions | Set options for DirectSparseSolverMA28 from OptionsFromStream object |
![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::VectorSpaceTesterSetOptions | Set options for VectorSpaceTester from an OptionsFromStream object |
![o](ftv2pnode.png) OptionsFromStreamPack::SetOptionsToTargetBase< BasisSystemTester > [external] | |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::BasisSystemTesterSetOptions | Set options for BasisSystemTester from an OptionsFromStream object |
![o](ftv2pnode.png) OptionsFromStreamPack::SetOptionsToTargetBase< DirectSparseSolverMA28 > [external] | |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::DirectSparseSolverMA28SetOptions | Set options for DirectSparseSolverMA28 from OptionsFromStream object |
![o](ftv2pnode.png) OptionsFromStreamPack::SetOptionsToTargetBase< VectorSpaceTester > [external] | |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::VectorSpaceTesterSetOptions | Set options for VectorSpaceTester from an OptionsFromStream object |
![o](ftv2node.png) AbstractLinAlgPack::BasisSystem::SingularBasis | |
![o](ftv2node.png) AbstractLinAlgPack::MatrixNonsing::SingularMatrix | This exception will be thrown if it turns out at runtime that the matrix is numerically singular |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymAddDelUpdateable::SingularUpdateException | Thrown if the matrix is singular and should not have been |
![o](ftv2node.png) AbstractLinAlgPack::SortByDescendingAbsValue | Function object class for sorting a sparse vectors in descending order by abs(v(i)) |
![o](ftv2node.png) AbstractLinAlgPack::sparse_bounds_itr | Iterate through a set of sparse bounds |
![o](ftv2node.png) AbstractLinAlgPack::SparseCOOPtrElement< T_Index, T_Value > | Sparse pointer element type for a COO matrix (val, ivect, jvect) |
![o](ftv2node.png) AbstractLinAlgPack::SparseElement< T_Index, T_Value > | Sparse storage element type |
![o](ftv2node.png) AbstractLinAlgPack::SparsePtrElement< T_Indice, T_Value > | Sparse pointer element type |
![o](ftv2node.png) AbstractLinAlgPack::SparseVector< T_Element, T_Alloc > | Sparse Vector class template |
![o](ftv2node.png) AbstractLinAlgPack::SparseVector< SparseElement< index_type, value_type >, std::allocator< SparseElement< index_type, value_type > > > | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorSlice< T_Element > | Sparse Vector Slice class template |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorSlice< SparseElement< index_type, value_type > > | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::SpVecIndexLookup< T_Element > | Sparse Vector Index Lookup and Caching class |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::SpVecIndexLookup< element_type > | |
![o](ftv2node.png) AbstractLinAlgPack::MatrixComposite::SubMatrixEntry | Matrix list entry for a sub-matrix |
![o](ftv2node.png) AbstractLinAlgPack::MatrixComposite::SubVectorEntry | Vector list entry for a sub-vector |
![o](ftv2node.png) AbstractLinAlgPack::COOMatrixPartitionedViewUtilityPack::TransposedPartition< T_Indice, T_Value > | Class for the transpose of a Partition |
![o](ftv2node.png) AbstractLinAlgPack::TransSparseCOOElementViewIter< T_Iter, T_IterCat, T_Indice, T_ValRef, T_Diff > | Templateded iterator for iterating through a set of COO Matix elements but viewing them in transpose |
![o](ftv2node.png) AbstractLinAlgPack::COOMatrixPartitionedView< T_Indice, T_Value >::UninitializedException | |
![o](ftv2node.png) AbstractLinAlgPack::SparseVectorUtilityPack::UnsizedException | |
![o](ftv2node.png) AbstractLinAlgPack::DirectSparseSolver::UnsymmetricRankDeficientException | |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymSecant::UpdateFailedException | |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymSecant::UpdateSkippedException | |
![o](ftv2pnode.png) AbstractLinAlgPack::Vector | Abstract interface for immutable, finite dimensional, coordinate vectors {abstract} |
![|](ftv2vertline.png) ![o](ftv2pnode.png) AbstractLinAlgPack::VectorMutable | Abstract interface for mutable coordinate vectors {abstract} |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::VectorMutableBlocked | Concrete subclass for a blocked vector |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::VectorMutableDense | DVector "Adaptor" subclass for DenseLinAlgPack::DVectorSlice or DenseLinAlgPack::DVector objects |
![|](ftv2vertline.png) ![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::VectorMutableSubView | Concrete subclass for a sub-view of a VectorMutable object |
![|](ftv2vertline.png) ![\](ftv2plastnode.png) AbstractLinAlgPack::VectorSubView | Concrete subclass for a default sub-view implementation for a Vector object |
![|](ftv2vertline.png) ![](ftv2blank.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::VectorMutableSubView | Concrete subclass for a sub-view of a VectorMutable object |
![o](ftv2pnode.png) AbstractLinAlgPack::VectorApplyOpSerialBase | This is a base class that is meant to be inherited by Vector subclasses that wish to call TSFCore::apply_op_serial() when vectors are in core |
![|](ftv2vertline.png) ![o](ftv2node.png) AbstractLinAlgPack::VectorMutableDense | DVector "Adaptor" subclass for DenseLinAlgPack::DVectorSlice or DenseLinAlgPack::DVector objects |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::VectorSubView | Concrete subclass for a default sub-view implementation for a Vector object |
![o](ftv2node.png) AbstractLinAlgPack::VectorDenseEncap | Extract a constant DenseLinAlgPack::DVectorSlice view of a Vector object |
![o](ftv2node.png) AbstractLinAlgPack::VectorDenseMutableEncap | Extract a non-const DenseLinAlgPack::DVectorSlice view of a VectorMutable object |
![o](ftv2pnode.png) AbstractLinAlgPack::VectorSpaceFactory | Abstract interface for objects that can create vector spaces of a specified dimension |
![|](ftv2vertline.png) ![\](ftv2lastnode.png) AbstractLinAlgPack::VectorSpaceFactorySerial | Abstract interface for objects that can create vector spaces of a specified dimension |
![o](ftv2node.png) AbstractLinAlgPack::VectorSpaceTester | Testing class for VectorSpace , Vector and VectorMutable |
![o](ftv2node.png) AbstractLinAlgPack::MatrixSymAddDelUpdateable::WarnNearSingularUpdateException | Thrown if the matrix is near singular as a warning |
![\](ftv2lastnode.png) AbstractLinAlgPack::MatrixSymAddDelUpdateable::WrongInertiaUpdateException | Thrown if matrix has the wrong inertia from what was expected |