►NEpetraExt | EpetraExt::BlockCrsMatrix: A class for constructing a distributed block matrix |
CBlockAdjacencyGraph | |
CBlockCrsMatrix | |
CBlockMultiVector | |
CBlockUtility | |
CBlockVector | |
CCrsGraph_AMD | EpetraExt::CrsGraph_AMD: A transform for Approximate Minimum Degree Reordering using Tim Daley's AMD Algorithm |
CCrsGraph_BTF | Block Triangular Factorization (Reordering) of Epetra_CrsGraph |
CCrsGraph_MapColoring | Map Coloring of independent columns in a Graph |
CCrsGraph_MapColoringIndex | |
CCrsGraph_MapColoringIndex64 | |
CCrsGraph_Overlap | Given an input Epetra_CrsGraph, a "overlapped" Epetra_CrsGraph is generated including rows associated with off processor contributions |
►CCrsGraph_SymmRCM | Generates the symmetric RCM reordered version of a Epetra_CrsGraph |
CBFT | |
CCrsGraph_Transpose | Transform to generate the explicit transpose of a Epetra_CrsGraph |
CCrsGraph_View | Generates a sub-block view of a Epetra_CrsGraph |
CCrsMatrix_BTF | |
CCrsMatrix_Dirichlet | Given an input Epetra_LinearProblem, apply given dirichlet conditions |
CCrsMatrix_Reindex | Given an Epetra_CrsMatrix, a "reindexed" version is returned based on the new row map |
CCrsMatrix_SolverMap | Given an input Epetra_CrsMatrix, the column map is checked for missing indices associated with the local rows |
CCrsMatrix_SubCopy | Generates a sub-block view of a Epetra_CrsMatrix |
CCrsMatrix_View | Generates a sub-block view of a Epetra_CrsMatrix |
CCrsMatrixStruct | |
CCrsWrapper | |
CCrsWrapper_Epetra_CrsMatrix | |
CCrsWrapper_GraphBuilder | |
CDiagonalQuadraticResponseOnlyModelEvaluator | A simple quadratic parallel response-only model evaluator |
CDiagonalTransientModel | Simple transient diagonal model for an implicit or explicit ODE |
CDirectory | Distributed Directory Tool |
CDistArray | DistArray<T>: A class to store row-oriented multivectors of type T |
CEpetra_Timed_Operator | Class allows for timing the action and inverse action of an Epetra_Opetator |
CEpetra_Vector_Handle | |
CEpetraExt_MatlabEngine | A class which provides data and command access to Matlab from Epetra |
CException | |
CHandle | |
CHash | |
CHash< std::string > | |
CHDF5 | Class HDF5: A class for storing Epetra objects in parallel binary files |
CInArgsGetterSetter_p | Class that gets and sets p(l) in an InArgs object |
CInArgsGetterSetter_x | Class that gets and sets x in an InArgs object |
CInArgsGetterSetter_x_dot | Class that gets and sets x_dot in an InArgs object |
CInArgsGetterSetter_x_dotdot | Class that gets and sets x_dotdot in an InArgs object |
CInPlaceTransform | |
CLightweightCrsMatrix | |
CLightweightMap | |
CLightweightMapData | |
CLinearProblem_BlockJacobi | |
CLinearProblem_BTF | |
CLinearProblem_CrsSingletonFilter | Epetra_CrsSingletonFilter: A class for explicitly eliminating matrix rows and columns |
CLinearProblem_GraphTrans | EpetraExt::LinearProblem_GraphTrans: Adaptation of a Epetra_CrsGraph Transform to a Epetra_LinearProblem Transform |
CLinearProblem_MatrixTrans | Adaptation of an Epetra_CrsMatrix Transform to a Epetra_LinearProblem Transform |
CLinearProblem_Reindex | Given and input Epetra_LinearProblem, a "reindexed" version will be returned using the given NewRowMap |
CLinearProblem_Reindex2 | Given and input Epetra_LinearProblem, a "reindexed" version will be returned using the given NewRowMap |
CLinearProblem_Scale | Given an input Epetra_LinearProblem, recursive, left and right scaling are performed |
CLinearProblem_SolverMap | Constructs a LinearProblem with a "fixed" Column Map for the CrsMatrix |
CLinearProblem_StaticCondensation | |
CMatrixMatrix | Collection of matrix-matrix operations |
CMigrate | Data Migration Utility used by EpetraExt::Directory |
CMigrate1 | |
►CModelEvaluator | Base interface for evaluating a stateless "model" |
CDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
CDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
CDerivativeProperties | |
CDerivativeSupport | |
CEvaluation | |
CInArgs | |
CInArgsSetup | |
CMPDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
CMPDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
COutArgs | |
COutArgsSetup | |
CPreconditioner | Simple aggregate struct that stores a preconditioner as an Epetra_Operator and a bool, about whether it is inverted or not |
CSGDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
CSGDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
CMultiComm | |
CMultiMpiComm | |
CMultiPointModelEvaluator | |
CMultiSerialComm | |
CMultiVector_Reindex | Given an input Epetra_MultiVector, a "reindexed" view is returned |
CMultiVector_View | Generates a sub-block view of a Epetra_MultiVector |
COutArgsGetterSetter_f | Class that gets and sets f in an OutArgs object |
COutArgsGetterSetter_g | Class that gets and sets g(j) in an OutArgs object |
CPackTraits | Traits for packing and unpacking of data into char buffers for communication |
CPackTraits< std::string > | Full specialization of PackTraits for std::string |
CPackTraits< std::vector< T > > | Partial specialization of PackTraits for std::vector<> containing a primitive type |
CPerm_traits | Define some traits to make it easier to deal with template-parameters which are objects to be permuted |
CPerm_traits< Epetra_CrsGraph > | A specialization of Perm_traits for the specific type Epetra_CrsGraph |
CPerm_traits< Epetra_CrsMatrix > | A specialization of Perm_traits for the specific type Epetra_CrsMatrix |
CPerm_traits< Epetra_MultiVector > | A specialization of Perm_traits for the specific type Epetra_MultiVector |
CPermutation | |
CPermutation64 | |
CProductOperator | Implements Epetra_Operator as a product of one or more Epetra_Operator objects |
CRemoteOnlyImport | |
CRowMatrix_Transpose | Transform to form the explicit transpose of a Epetra_RowMatrix |
CSameTypeTransform | |
CStructuralSameTypeTransform | |
CStructuralTransform | |
CTCrsGraph_MapColoringIndex | Generates a std::vector of Epetra_IntVector's to be used to map perturbation contributions to a CrsGraph/CrsMatrix from a perturbed vector |
CTPermutation | Permutation stores and describes a permutation matrix P |
CTransform | Base Class for all Epetra Transform Operators |
CTransform_Composite | Composition Class for Epetra Transform SameType Operators |
CVector_Dirichlet | Given an input Epetra_Vector, apply given dirichlet conditions |
CViewTransform | |
CXMLReader | Class XMLReader: A class for reading Epetra objects stored in XML files |
CXMLWriter | Class XMLWriter: A class for writing Trilinos objects to XML files |
►NGenSQP | |
CDataPool | Provides the interface to a generic data pool |
CVector | Provides the interface to generic abstract vector libraries |
CYUEpetraVector | The GenSQP::Vector / (y,u) Epetra_MultiVector adapter class |
►NGLpApp | |
CAdvDiffReactOptModel | PDE-constrained inverse problem based on a 2D discretization of a diffusion/reaction system |
CAdvDiffReactOptModelCreator | A utility class for creating an AdvDiffReactOptModelCreator/tt> object by reading from the command-line |
CGLpYUEpetraDataPool | |
CUsr_Par | |
NMatlab | |
►NStokhos | |
COrthogPolyBasis | |
COrthogPolyExpansion | |
CQuadrature | |
CStandardStorage | |
►NTeuchos | |
CPolynomialTraits< Epetra_Vector > | Specilization of Teuchos::PolynomialTraits for Epetra vectors |