EpetraExt | EpetraExt::BlockCrsMatrix: A class for constructing a distributed block matrix |
BlockCrsMatrix | |
BlockMultiVector | |
BlockUtility | |
BlockVector | |
MultiComm | |
MultiMpiComm | |
MultiPointModelEvaluator | |
MultiSerialComm | |
LinearProblem_BlockJacobi | |
CrsGraph_BTF | Block Triangular Factorization (Reordering) of Epetra_CrsGraph |
CrsMatrix_BTF | |
LinearProblem_BTF | |
CrsGraph_MapColoring | Map Coloring of independent columns in a Graph |
CrsGraph_MapColoringIndex | |
CrsGraph_MapColoringIndex64 | |
TCrsGraph_MapColoringIndex | Generates a std::vector of Epetra_IntVector's to be used to map perturbation contributions to a CrsGraph/CrsMatrix from a perturbed vector |
Directory | Distributed Directory Tool |
Hash | |
Hash< std::string > | |
Migrate | Data Migration Utility used by EpetraExt::Directory |
Migrate1 | |
PackTraits | Traits for packing and unpacking of data into char buffers for communication |
PackTraits< std::string > | Full specialization of PackTraits for std::string |
PackTraits< std::vector< T > > | Partial specialization of PackTraits for std::vector<> containing a primitive type |
MatrixMatrix | Collection of matrix-matrix operations |
CrsMatrixStruct | |
CrsWrapper | |
CrsWrapper_Epetra_CrsMatrix | |
CrsWrapper_GraphBuilder | |
LightweightMapData | |
LightweightMap | |
RemoteOnlyImport | |
LightweightCrsMatrix | |
ProductOperator | Implements Epetra_Operator as a product of one or more Epetra_Operator objects |
Epetra_Timed_Operator | Class allows for timing the action and inverse action of an Epetra_Opetator |
DistArray | DistArray<T>: A class to store row-oriented multivectors of type T |
Exception | |
HDF5 | Class HDF5: A class for storing Epetra objects in parallel binary files |
Handle | |
Epetra_Vector_Handle | |
XMLReader | Class XMLReader: A class for reading Epetra objects stored in XML files |
XMLWriter | Class XMLWriter: A class for writing Trilinos objects to XML files |
EpetraExt_MatlabEngine | A class which provides data and command access to Matlab from Epetra |
ModelEvaluator | Base interface for evaluating a stateless "model" |
Derivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
DerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
DerivativeProperties | |
DerivativeSupport | |
Evaluation | |
InArgs | |
InArgsSetup | |
MPDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
MPDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
OutArgs | |
OutArgsSetup | |
Preconditioner | Simple aggregate struct that stores a preconditioner as an Epetra_Operator and a bool, about whether it is inverted or not |
SGDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
SGDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
InArgsGetterSetter_x_dot | Class that gets and sets x_dot in an InArgs object |
InArgsGetterSetter_x_dotdot | Class that gets and sets x_dotdot in an InArgs object |
InArgsGetterSetter_x | Class that gets and sets x in an InArgs object |
InArgsGetterSetter_p | Class that gets and sets p(l) in an InArgs object |
OutArgsGetterSetter_f | Class that gets and sets f in an OutArgs object |
OutArgsGetterSetter_g | Class that gets and sets g(j) in an OutArgs object |
CrsGraph_AMD | EpetraExt::CrsGraph_AMD: A transform for Approximate Minimum Degree Reordering using Tim Daley's AMD Algorithm |
BlockAdjacencyGraph | |
LinearProblem_CrsSingletonFilter | Epetra_CrsSingletonFilter: A class for explicitly eliminating matrix rows and columns |
CrsMatrix_Dirichlet | Given an input Epetra_LinearProblem, apply given dirichlet conditions |
Vector_Dirichlet | Given an input Epetra_Vector, apply given dirichlet conditions |
LinearProblem_GraphTrans | EpetraExt::LinearProblem_GraphTrans: Adaptation of a Epetra_CrsGraph Transform to a Epetra_LinearProblem Transform |
LinearProblem_MatrixTrans | Adaptation of an Epetra_CrsMatrix Transform to a Epetra_LinearProblem Transform |
CrsGraph_Overlap | Given an input Epetra_CrsGraph, a "overlapped" Epetra_CrsGraph is generated including rows associated with off processor contributions |
TPermutation | Permutation stores and describes a permutation matrix P |
Permutation | |
Permutation64 | |
Perm_traits | Define some traits to make it easier to deal with template-parameters which are objects to be permuted |
Perm_traits< Epetra_CrsMatrix > | A specialization of Perm_traits for the specific type Epetra_CrsMatrix |
Perm_traits< Epetra_CrsGraph > | A specialization of Perm_traits for the specific type Epetra_CrsGraph |
Perm_traits< Epetra_MultiVector > | A specialization of Perm_traits for the specific type Epetra_MultiVector |
CrsMatrix_Reindex | Given an Epetra_CrsMatrix, a "reindexed" version is returned based on the new row map |
LinearProblem_Reindex | Given and input Epetra_LinearProblem, a "reindexed" version will be returned using the given NewRowMap |
LinearProblem_Reindex2 | Given and input Epetra_LinearProblem, a "reindexed" version will be returned using the given NewRowMap |
MultiVector_Reindex | Given an input Epetra_MultiVector, a "reindexed" view is returned |
LinearProblem_Scale | Given an input Epetra_LinearProblem, recursive, left and right scaling are performed |
CrsMatrix_SolverMap | Given an input Epetra_CrsMatrix, the column map is checked for missing indices associated with the local rows |
LinearProblem_SolverMap | Constructs a LinearProblem with a "fixed" Column Map for the CrsMatrix |
LinearProblem_StaticCondensation | |
CrsMatrix_SubCopy | Generates a sub-block view of a Epetra_CrsMatrix |
CrsGraph_SymmRCM | Generates the symmetric RCM reordered version of a Epetra_CrsGraph |
BFT | |
Transform | Base Class for all Epetra Transform Operators |
StructuralTransform | |
SameTypeTransform | |
StructuralSameTypeTransform | |
InPlaceTransform | |
ViewTransform | |
Transform_Composite | Composition Class for Epetra Transform SameType Operators |
CrsGraph_Transpose | Transform to generate the explicit transpose of a Epetra_CrsGraph |
RowMatrix_Transpose | Transform to form the explicit transpose of a Epetra_RowMatrix |
CrsGraph_View | Generates a sub-block view of a Epetra_CrsGraph |
CrsMatrix_View | Generates a sub-block view of a Epetra_CrsMatrix |
MultiVector_View | Generates a sub-block view of a Epetra_MultiVector |
DiagonalQuadraticResponseOnlyModelEvaluator | A simple quadratic parallel response-only model evaluator |
DiagonalTransientModel | Simple transient diagonal model for an implicit or explicit ODE |
GenSQP | |
DataPool | Provides the interface to a generic data pool |
Vector | Provides the interface to generic abstract vector libraries |
YUEpetraVector | The GenSQP::Vector / (y,u) Epetra_MultiVector adapter class |
GLpApp | |
AdvDiffReactOptModel | PDE-constrained inverse problem based on a 2D discretization of a diffusion/reaction system |
AdvDiffReactOptModelCreator | A utility class for creating an AdvDiffReactOptModelCreator/tt> object by reading from the command-line |
GLpYUEpetraDataPool | |
Usr_Par | |
Matlab | |
Stokhos | |
OrthogPolyBasis | |
Quadrature | |
StandardStorage | |
OrthogPolyExpansion | |
Teuchos | |
details | |
complex< T > > | |
MatrixMarket | |
YAMLParameterList | |
string > | |
false_type > | |
true_type > | |
false_type > | |
true_type > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string, char[N]> | |
reverse_iterator< Iter > > | |
string > | |
pair< T1, T2 > > | |
string > | |
DefaultSerializerType > | |
pair< P1, P2 > > | |
DefaultSerializerType > | |
DefaultSerializerType > | |
DefaultSerializerType > | |
DefaultSerializerType > | |
pair< Packet, Packet > > | |
pair< Packet, Packet >, ConvertToPacket > | |
complex< float > > | |
complex< double > > | |
PolynomialTraits< Epetra_Vector > | Specilization of Teuchos::PolynomialTraits for Epetra vectors |
Trilinos | |
Details | |
Epetra_PETScAIJMatrix | Epetra_PETScAIJMatrix: A class for constructing and using real-valued sparse compressed row matrices |
EpetraExt_BlockDiagMatrix | EpetraExt_BlockDiagMatrix: A class for storing distributed block matrices |
EpetraExt_HypreIJMatrix | |
EpetraExt_PointToBlockDiagPermute | EpetraExt_PointToBlockDiagPermute: A class for managing point-to-block-diagonal permutations |
EpetraModelEval2DSim | Simple example ModelEvaluator subclass for a 2x2 set of parameterized nonlinear equations |
EpetraModelEval4DOpt | A simple serial example model which includes a parameter subvector and a response function that can be used to define an optimization problem |
EpetraMultiPointModelEval4DOpt | A simple serial example model which includes a parameter subvector and a response function that can be used to define an optimization problem |
FindDataset_t | |
Poisson2dOperator | Poisson2dOperator: A sample implementation of the Epetra_Operator class |