| 
    Thyra Package Browser (Single Doxygen Collection)
    Version of the Day
    
   | 
 
Classes | |
| class | DiagonalEpetraLinearOpWithSolveFactory | 
| Create a DefaultDiagonalLinearOpWithSolve out of a diagonal Epetra_RowMatrix object.  More... | |
| class | EpetraLinearOp | 
Concrete LinearOpBase adapter subclass for Epetra_Operator object.  More... | |
| class | EpetraLinearOpBase | 
Abstract base class for all LinearOpBase objects that can return an Epetra_Operator view of themselves and details about how to apply the view.  More... | |
| class | EpetraOperatorViewExtractorBase | 
Strategy interface for extracting an Epetra_Operator view out of a Thyra::LinearOpBase<double> object.  More... | |
| class | EpetraOperatorViewExtractorStd | 
Standard strategy subclass for extracting an Epetra_Operator view out of a Thyra::LinearOpBase<double> object by dynamic casting to the EpetraLinearOpBase interface.  More... | |
| class | EpetraOperatorWrapper | 
| Implements the Epetra_Operator interface with a Thyra LinearOperator.  More... | |
| class | EpetraModelEvaluator | 
Concrete Adapter subclass that takes an EpetraExt::ModelEvaluator object and wraps it as a Thyra::ModelEvaluator object.  More... | |
| class | EpetraExtAddTransformer | 
| Transformer subclass for adding Epetra/Thyra operators using EpetraExt::MatrixMatrix.  More... | |
| class | EpetraExtDiagScaledMatProdTransformer | 
| Transformer subclass for diagonally scaling and multiplying Epetra/Thyra operators.  More... | |
| class | EpetraExtDiagScalingTransformer | 
| Transformer subclass for diagonally scaling a Epetra/Thyra operator.  More... | |
| class | TpetraEuclideanScalarProd | 
| Extends concrete implementation of a Euclidean scalar product for specifically Tpetra vectors/multivectors.  More... | |
| class | TpetraLinearOp | 
| Concrete Thyra::LinearOpBase subclass for Tpetra::Operator.  More... | |
| class | TpetraMultiVector | 
| Concrete implementation of Thyra::MultiVector in terms of Tpetra::MultiVector.  More... | |
| class | TpetraOperatorVectorExtraction | 
| Traits class that enables the extraction of Tpetra operator/vector objects wrapped in Thyra operator/vector objects.  More... | |
| class | TpetraVector | 
| Concrete Thyra::SpmdVectorBase using Tpetra::Vector.  More... | |
| class | TpetraVectorSpace | 
| Concrete implementation of an SPMD vector space for Tpetra.  More... | |
| class | CopyTpetraMultiVectorViewBack | 
Typedefs | |
| typedef Tpetra::Map | TpetraMap_t | 
Enumerations | |
| enum | EAdjointEpetraOp { EPETRA_OP_ADJOINT_SUPPORTED, EPETRA_OP_ADJOINT_UNSUPPORTED } | 
| Determine if adjoints are supported on Epetra_Opeator or not.  More... | |
| enum | EApplyEpetraOpAs { EPETRA_OP_APPLY_APPLY, EPETRA_OP_APPLY_APPLY_INVERSE } | 
| Determine how the apply an Epetra_Operator as a linear operator.  More... | |
Functions | |
| RCP< const Teuchos::Comm < Ordinal > >  | create_Comm (const RCP< const Epetra_Comm > &epetraComm) | 
Given an Epetra_Comm object, return an equivalent Teuchos::Comm object.  More... | |
| RCP< const VectorSpaceBase < double > >  | create_VectorSpace (const RCP< const Epetra_Map > &epetra_map) | 
Create an VectorSpaceBase object given an Epetra_Map object.  More... | |
| RCP< const VectorSpaceBase < double > >  | create_LocallyReplicatedVectorSpace (const RCP< const VectorSpaceBase< double > > &parentSpace, const int dim) | 
Create a VectorSpaceBase object that creates locally replicated vector objects.  More... | |
| RCP< VectorBase< double > > | create_Vector (const RCP< Epetra_Vector > &epetra_v, const RCP< const VectorSpaceBase< double > > &space=Teuchos::null) | 
Create a non-const VectorBase object from a non-const Epetra_Vector object.  More... | |
| RCP< const VectorBase< double > > | create_Vector (const RCP< const Epetra_Vector > &epetra_v, const RCP< const VectorSpaceBase< double > > &space=Teuchos::null) | 
Create an const VectorBase wrapper object for a const Epetra_Vector object.  More... | |
| RCP< MultiVectorBase< double > > | create_MultiVector (const RCP< Epetra_MultiVector > &epetra_mv, const RCP< const VectorSpaceBase< double > > &range=Teuchos::null, const RCP< const VectorSpaceBase< double > > &domain=Teuchos::null) | 
Create a non-const MultiVectorBase object from a non-const Epetra_MultiVector object.  More... | |
| RCP< const MultiVectorBase < double > >  | create_MultiVector (const RCP< const Epetra_MultiVector > &epetra_mv, const RCP< const VectorSpaceBase< double > > &range=Teuchos::null, const RCP< const VectorSpaceBase< double > > &domain=Teuchos::null) | 
Create an const MultiVectorBase wrapper object for a const Epetra_MultiVector object.  More... | |
| RCP< const Epetra_Comm > | get_Epetra_Comm (const Teuchos::Comm< Ordinal > &comm) | 
Get (or create) and Epetra_Comm given a Teuchos::Comm object.  More... | |
| RCP< const Epetra_Map > | get_Epetra_Map (const VectorSpaceBase< double > &vs, const RCP< const Epetra_Comm > &comm) | 
Get (or create) an Epetra_Map object given an VectorSpaceBase object an optionally an extra Epetra_Comm object.  More... | |
| RCP< const Epetra_Map > | get_Epetra_Map (const RCP< const VectorSpaceBase< double >> &vs, const RCP< const Epetra_Comm > &comm=Teuchos::null) | 
| RCP< Epetra_Vector > | get_Epetra_Vector (const Epetra_Map &map, const RCP< VectorBase< double > > &v) | 
Get a non-const Epetra_Vector view from a non-const VectorBase object if possible.  More... | |
| RCP< Epetra_Vector > | get_Epetra_Vector (const RCP< VectorBase< double > > &v, const RCP< const Epetra_Map > &map=Teuchos::null) | 
| RCP< const Epetra_Vector > | get_Epetra_Vector (const Epetra_Map &map, const RCP< const VectorBase< double > > &v) | 
Get a const Epetra_Vector view from a const VectorBase object if possible.  More... | |
| RCP< const Epetra_Vector > | get_Epetra_Vector (const RCP< const VectorBase< double > > &v, const RCP< const Epetra_Map > &map=Teuchos::null) | 
| RCP< Epetra_MultiVector > | get_Epetra_MultiVector (const Epetra_Map &map, const RCP< MultiVectorBase< double > > &mv) | 
Get a non-const Epetra_MultiVector view from a non-const MultiVectorBase object if possible.  More... | |
| RCP< Epetra_MultiVector > | get_Epetra_MultiVector (const RCP< MultiVectorBase< double > > &mv, const RCP< const Epetra_Map > &map=Teuchos::null) | 
| RCP< const Epetra_MultiVector > | get_Epetra_MultiVector (const Epetra_Map &map, const RCP< const MultiVectorBase< double > > &mv) | 
Get a const Epetra_MultiVector view from a const MultiVectorBase object if possible.  More... | |
| RCP< const Epetra_MultiVector > | get_Epetra_MultiVector (const RCP< const MultiVectorBase< double > > &mv, const RCP< const Epetra_Map > &map=Teuchos::null) | 
| Teuchos::RCP< Epetra_MultiVector > | get_Epetra_MultiVector (const Epetra_Map &map, MultiVectorBase< double > &mv) | 
Get a non-const Epetra_MultiVector view from a non-const MultiVectorBase object if possible where the client must maintain the memory of the input multivector.  More... | |
| Teuchos::RCP< const  Epetra_MultiVector >  | get_Epetra_MultiVector (const Epetra_Map &map, const MultiVectorBase< double > &mv) | 
Get a const Epetra_MultiVector view from a const MultiVectorBase object if possible where the client must maintain the memory of the input multivector.  More... | |
| const std::string | toString (const EAdjointEpetraOp adjointEpetraOp) | 
| const std::string | toString (const EApplyEpetraOpAs applyEpetraOpAs) | 
| template<> | |
| Teuchos::RCP< Epetra_Operator > | get_Epetra_Operator (LinearOpBase< double > &op) | 
| Full specialization for Scalar=double.  More... | |
| template<> | |
| Teuchos::RCP< const  Epetra_Operator >  | get_Epetra_Operator (const LinearOpBase< double > &op) | 
| Full specialization for Scalar=double.  More... | |
| template<class Scalar > | |
| Teuchos::RCP< Epetra_Operator > | get_Epetra_Operator (LinearOpBase< Scalar > &) | 
Get smart pointer to non-const Epetra_Operator object from reference to a non-const EpetraLinearOp accessed through its LinearOpBase interface.  More... | |
| template<class Scalar > | |
| Teuchos::RCP< const  Epetra_Operator >  | get_Epetra_Operator (const LinearOpBase< Scalar > &) | 
Get smart pointer to const Epetra_Operator object from reference to a const EpetraLinearOp accessed through its LinearOpBase interface.  More... | |
| TEUCHOS_UNIT_TEST (EpetraOperatorWrapper, basic) | |
| TEUCHOS_UNIT_TEST (EpetraLinearOp, ScaledLinearOpBase) | |
| TEUCHOS_UNIT_TEST (EpetraLinearOp, RowStatLinearOpBase) | |
| RCP< Epetra_CrsMatrix > | getMyEpetraMatrix (int numRows, int numCols, double shift=0.0) | 
| TEUCHOS_UNIT_TEST (EpetraLinearOp, Blocked_ScaledLinearOpBase) | |
| TEUCHOS_UNIT_TEST (EpetraLinearOp, Blocked_RowStatLinearOpBase) | |
| TEUCHOS_UNIT_TEST (EpetraLinearOp, Blocked_ScalingWithMultiVectors) | |
| TEUCHOS_UNIT_TEST (EpetraLinearOp, rectangular) | |
| TEUCHOS_UNIT_TEST (EpetraLinearOp, blocked_op) | |
| TEUCHOS_UNIT_TEST (EpetraLinearOpParallel, blocked_op) | |
| EpetraExt::ModelEvaluator::MPDerivative | convert (const ModelEvaluatorBase::MPDerivative &derivative, const RCP< const Epetra_Map > &fnc_map, const RCP< const Epetra_Map > &var_map) | 
| template<class Scalar > | |
| Teuchos::ETransp | convertConjNoTransToTeuchosTransMode () | 
| template<class Scalar > | |
| Teuchos::ETransp | convertToTeuchosTransMode (const Thyra::EOpTransp transp) | 
| RCP< const Teuchos::Comm < Ordinal > >  | convertTpetraToThyraComm (const RCP< const Teuchos::Comm< int > > &tpetraComm) | 
Given an Tpetra Teuchos::Comm<int> object, return an equivalent Teuchos::Comm<Ordinal> object.  More... | |
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< const VectorSpaceBase < Scalar > >  | createVectorSpace (const RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > &tpetraMap) | 
| Create a Thyra::VectorSpaceBase object given a Tpetra::Map.  More... | |
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< VectorBase< Scalar > > | createVector (const RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector, const RCP< const VectorSpaceBase< Scalar > > space=Teuchos::null) | 
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< const VectorBase< Scalar > > | createConstVector (const RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector, const RCP< const VectorSpaceBase< Scalar > > space=Teuchos::null) | 
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< MultiVectorBase< Scalar > > | createMultiVector (const RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraMultiVector, const RCP< const VectorSpaceBase< Scalar > > rangeSpace=Teuchos::null, const RCP< const VectorSpaceBase< Scalar > > domainSpace=Teuchos::null) | 
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< const MultiVectorBase < Scalar > >  | createConstMultiVector (const RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraMultiVector, const RCP< const VectorSpaceBase< Scalar > > rangeSpace=Teuchos::null, const RCP< const VectorSpaceBase< Scalar > > domainSpace=Teuchos::null) | 
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< LinearOpBase< Scalar > > | createLinearOp (const RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraOperator, const RCP< const VectorSpaceBase< Scalar > > rangeSpace=Teuchos::null, const RCP< const VectorSpaceBase< Scalar > > domainSpace=Teuchos::null) | 
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< const LinearOpBase< Scalar > > | createConstLinearOp (const RCP< const Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraOperator, const RCP< const VectorSpaceBase< Scalar > > rangeSpace=Teuchos::null, const RCP< const VectorSpaceBase< Scalar > > domainSpace=Teuchos::null) | 
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| Teuchos::RCP< const  TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > >  | getOrCreateTpetraVectorSpace (const RCP< const VectorSpaceBase< Scalar > > space, const RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > &tpetraMap) | 
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| Teuchos::RCP< const  ScalarProdVectorSpaceBase < Scalar > >  | getOrCreateLocallyReplicatedTpetraVectorSpace (const RCP< const VectorSpaceBase< Scalar > > space, const RCP< const Teuchos::Comm< int > > &tpetraComm, const int numCols) | 
| RCP< const TpetraMap_t > | createTpetraMap (const int localDim) | 
| template<class Scalar > | |
| RCP< const VectorSpaceBase < Scalar > >  | createTpetraVectorSpace (const int localDim) | 
| template<class Scalar > | |
| RCP< Tpetra::Operator< Scalar > > | createTriDiagonalTpetraOperator (const int numLocalRows) | 
| TEUCHOS_STATIC_SETUP () | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, convertTpetraToThyraComm, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, createVectorSpace, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, createVector, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, createConstVector, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, createMultiVector, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, createConstMultiVector, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, TeptraVectorSpace, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, vectorSpaceTester, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, vectorStdOpsTester, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, multiVectorStdOpsTester, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, getTpetraMultiVector, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, getConstTpetraMultiVector, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, TpetraLinearOp, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, createLinearOp, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, createConstLinearOp, Scalar) | |
| Teuchos::RCP< Teuchos::Time > | lookupAndAssertTimer (const std::string &label) | 
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, UseTpetraImplementations, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, TpetraLinearOp_EpetraRowMatrix, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, TpetraLinearOp_RowStatLinearOpBase, Scalar) | |
| TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (TpetraThyraWrappers, TpetraLinearOp_ScaledLinearOpBase, Scalar) | |
Variables | |
| const int | g_localDim = 4 | 
| bool | showAllTests = false | 
| bool | dumpAll = false | 
| bool | runLinearOpTester = true | 
| typedef Tpetra::Map Thyra::TpetraMap_t | 
Definition at line 85 of file TpetraThyraWrappers_UnitTests.cpp.
| Teuchos::RCP< const Epetra_Map > Thyra::get_Epetra_Map | ( | const RCP< const VectorSpaceBase< double >> & | vs, | 
| const RCP< const Epetra_Comm > & | comm = Teuchos::null  | 
        ||
| ) | 
Definition at line 512 of file Thyra_EpetraThyraWrappers.cpp.
References get_Epetra_Map(), is_null(), Teuchos::RCP< T >::is_null(), and TEUCHOS_TEST_FOR_EXCEPTION.
| Teuchos::RCP< Epetra_Vector > Thyra::get_Epetra_Vector | ( | const RCP< VectorBase< double > > & | v, | 
| const RCP< const Epetra_Map > & | map = Teuchos::null  | 
        ||
| ) | 
Definition at line 618 of file Thyra_EpetraThyraWrappers.cpp.
References get_Epetra_Vector(), is_null(), Teuchos::RCP< T >::is_null(), and TEUCHOS_TEST_FOR_EXCEPTION.
| Teuchos::RCP< const Epetra_Vector > Thyra::get_Epetra_Vector | ( | const RCP< const VectorBase< double > > & | v, | 
| const RCP< const Epetra_Map > & | map = Teuchos::null  | 
        ||
| ) | 
Definition at line 717 of file Thyra_EpetraThyraWrappers.cpp.
References get_Epetra_Vector(), is_null(), Teuchos::RCP< T >::is_null(), and TEUCHOS_TEST_FOR_EXCEPTION.
| Teuchos::RCP< Epetra_MultiVector > Thyra::get_Epetra_MultiVector | ( | const RCP< MultiVectorBase< double > > & | mv, | 
| const RCP< const Epetra_Map > & | map = Teuchos::null  | 
        ||
| ) | 
Definition at line 825 of file Thyra_EpetraThyraWrappers.cpp.
References get_Epetra_MultiVector(), is_null(), Teuchos::RCP< T >::is_null(), and TEUCHOS_TEST_FOR_EXCEPTION.
| Teuchos::RCP< const Epetra_MultiVector > Thyra::get_Epetra_MultiVector | ( | const RCP< const MultiVectorBase< double > > & | mv, | 
| const RCP< const Epetra_Map > & | map = Teuchos::null  | 
        ||
| ) | 
Definition at line 930 of file Thyra_EpetraThyraWrappers.cpp.
References get_Epetra_MultiVector(), is_null(), Teuchos::RCP< T >::is_null(), and TEUCHOS_TEST_FOR_EXCEPTION.
| Teuchos::RCP< Epetra_Operator > Thyra::get_Epetra_Operator | ( | LinearOpBase< double > & | op | ) | 
Full specialization for Scalar=double.
Definition at line 50 of file Thyra_get_Epetra_Operator.cpp.
References Teuchos::dyn_cast(), and Thyra::EpetraLinearOp::epetra_op().
Referenced by scaleFirstDiagElement(), Thyra::EpetraExtAddTransformer::transform(), Thyra::EpetraExtDiagScaledMatProdTransformer::transform(), and Thyra::EpetraExtDiagScalingTransformer::transform().
| Teuchos::RCP< const Epetra_Operator > Thyra::get_Epetra_Operator | ( | const LinearOpBase< double > & | op | ) | 
Full specialization for Scalar=double.
Definition at line 58 of file Thyra_get_Epetra_Operator.cpp.
References Teuchos::dyn_cast(), and Thyra::EpetraLinearOp::epetra_op().
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraOperatorWrapper | , | 
| basic | |||
| ) | 
Definition at line 83 of file EpetraOperatorWrapper_UnitTests.cpp.
References Teuchos::RCP< T >::ptr(), rcp(), TEST_ASSERT, and TEST_EQUALITY.
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , | 
| ScaledLinearOpBase | |||
| ) | 
Definition at line 85 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, NOTRANS, Teuchos::null, Teuchos::RCP< T >::ptr(), TEST_FLOATING_EQUALITY, and Teuchos::updateSuccess().
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , | 
| RowStatLinearOpBase | |||
| ) | 
Definition at line 251 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, Teuchos::null, Teuchos::RCP< T >::ptr(), TEST_FLOATING_EQUALITY, and Teuchos::updateSuccess().
| RCP<Epetra_CrsMatrix> Thyra::getMyEpetraMatrix | ( | int | numRows, | 
| int | numCols, | ||
| double | shift = 0.0  | 
        ||
| ) | 
Definition at line 307 of file EpetraLinearOp_UnitTests.cpp.
Referenced by TEUCHOS_UNIT_TEST().
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , | 
| Blocked_ScaledLinearOpBase | |||
| ) | 
Definition at line 335 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, getMyEpetraMatrix(), Teuchos::null, Teuchos::RCP< T >::ptr(), updateSuccess(), and Teuchos::updateSuccess().
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , | 
| Blocked_RowStatLinearOpBase | |||
| ) | 
Definition at line 418 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, Teuchos::null, Teuchos::RCP< T >::ptr(), TEST_FLOATING_EQUALITY, and Teuchos::updateSuccess().
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , | 
| Blocked_ScalingWithMultiVectors | |||
| ) | 
Definition at line 487 of file EpetraLinearOp_UnitTests.cpp.
References Teuchos::DefaultComm< class >::getComm(), getMyEpetraMatrix(), Teuchos::null, Teuchos::RCP< T >::ptr(), TEST_FLOATING_EQUALITY, Teuchos::updateSuccess(), updateSuccess(), and Teuchos::VERB_EXTREME.
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , | 
| rectangular | |||
| ) | 
Definition at line 606 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, Teuchos::null, updateSuccess(), and Teuchos::updateSuccess().
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , | 
| blocked_op | |||
| ) | 
Definition at line 635 of file EpetraLinearOp_UnitTests.cpp.
References Teuchos::GlobalMPISession::getNProc(), NOTRANS, Teuchos::RCP< T >::ptr(), Teuchos::VERB_HIGH, and Teuchos::VERB_MEDIUM.
| Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOpParallel | , | 
| blocked_op | |||
| ) | 
Definition at line 62 of file EpetraLinearOpParallel_UnitTests.cpp.
References Teuchos::VERB_MEDIUM.
| EpetraExt::ModelEvaluator::MPDerivative Thyra::convert | ( | const ModelEvaluatorBase::MPDerivative & | derivative, | 
| const RCP< const Epetra_Map > & | fnc_map, | ||
| const RCP< const Epetra_Map > & | var_map | ||
| ) | 
Definition at line 1651 of file Thyra_EpetraModelEvaluator.cpp.
References Thyra::EpetraModelEvaluator::convert().
      
  | 
  inline | 
Definition at line 105 of file Thyra_TpetraLinearOp_def.hpp.
References Teuchos::NO_TRANS, and TEUCHOS_TEST_FOR_EXCEPTION.
      
  | 
  inline | 
Definition at line 120 of file Thyra_TpetraLinearOp_def.hpp.
References Teuchos::CONJ_TRANS, CONJTRANS, Teuchos::NO_TRANS, NOTRANS, TEUCHOS_TEST_FOR_EXCEPT, Teuchos::TRANS, and TRANS.
| Teuchos::RCP< const Teuchos::Comm< Thyra::Ordinal > > Thyra::convertTpetraToThyraComm | ( | const RCP< const Teuchos::Comm< int > > & | tpetraComm | ) | 
Given an Tpetra Teuchos::Comm<int> object, return an equivalent Teuchos::Comm<Ordinal> object. 
Will throw if conversion is not successful.
Definition at line 55 of file Thyra_TpetraThyraWrappers.cpp.
References nonnull().
Referenced by Thyra::TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node >::initialize(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| RCP<const VectorSpaceBase<Scalar> > Thyra::createVectorSpace | ( | const RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > & | tpetraMap | ) | 
Create a Thyra::VectorSpaceBase object given a Tpetra::Map.
| RCP<VectorBase<Scalar> > Thyra::createVector | ( | const RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraVector, | 
| const RCP< const VectorSpaceBase< Scalar > > | space = Teuchos::null  | 
        ||
| ) | 
| RCP<const VectorBase<Scalar> > Thyra::createConstVector | ( | const RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraVector, | 
| const RCP< const VectorSpaceBase< Scalar > > | space = Teuchos::null  | 
        ||
| ) | 
Referenced by TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| RCP<MultiVectorBase<Scalar> > Thyra::createMultiVector | ( | const RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraMultiVector, | 
| const RCP< const VectorSpaceBase< Scalar > > | rangeSpace = Teuchos::null,  | 
        ||
| const RCP< const VectorSpaceBase< Scalar > > | domainSpace = Teuchos::null  | 
        ||
| ) | 
Referenced by TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| RCP<const MultiVectorBase<Scalar> > Thyra::createConstMultiVector | ( | const RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraMultiVector, | 
| const RCP< const VectorSpaceBase< Scalar > > | rangeSpace = Teuchos::null,  | 
        ||
| const RCP< const VectorSpaceBase< Scalar > > | domainSpace = Teuchos::null  | 
        ||
| ) | 
Referenced by TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| RCP<LinearOpBase<Scalar> > Thyra::createLinearOp | ( | const RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraOperator, | 
| const RCP< const VectorSpaceBase< Scalar > > | rangeSpace = Teuchos::null,  | 
        ||
| const RCP< const VectorSpaceBase< Scalar > > | domainSpace = Teuchos::null  | 
        ||
| ) | 
| RCP<const LinearOpBase<Scalar> > Thyra::createConstLinearOp | ( | const RCP< const Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraOperator, | 
| const RCP< const VectorSpaceBase< Scalar > > | rangeSpace = Teuchos::null,  | 
        ||
| const RCP< const VectorSpaceBase< Scalar > > | domainSpace = Teuchos::null  | 
        ||
| ) | 
Referenced by TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| Teuchos::RCP<const TpetraVectorSpace<Scalar,LocalOrdinal,GlobalOrdinal,Node> > Thyra::getOrCreateTpetraVectorSpace | ( | const RCP< const VectorSpaceBase< Scalar > > | space, | 
| const RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > & | tpetraMap | ||
| ) | 
Definition at line 58 of file Thyra_TpetraThyraWrappers_def.hpp.
References nonnull().
| Teuchos::RCP<const ScalarProdVectorSpaceBase<Scalar> > Thyra::getOrCreateLocallyReplicatedTpetraVectorSpace | ( | const RCP< const VectorSpaceBase< Scalar > > | space, | 
| const RCP< const Teuchos::Comm< int > > & | tpetraComm, | ||
| const int | numCols | ||
| ) | 
Definition at line 78 of file Thyra_TpetraThyraWrappers_def.hpp.
References nonnull().
| RCP<const TpetraMap_t> Thyra::createTpetraMap | ( | const int | localDim | ) | 
Definition at line 89 of file TpetraThyraWrappers_UnitTests.cpp.
References Teuchos::rcp().
Referenced by createTpetraVectorSpace(), createTriDiagonalTpetraOperator(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| RCP<const VectorSpaceBase<Scalar> > Thyra::createTpetraVectorSpace | ( | const int | localDim | ) | 
Definition at line 102 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), and g_localDim.
| RCP<Tpetra::Operator<Scalar> > Thyra::createTriDiagonalTpetraOperator | ( | const int | numLocalRows | ) | 
Definition at line 110 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), and Teuchos::rcp().
| Thyra::TEUCHOS_STATIC_SETUP | ( | ) | 
Definition at line 190 of file TpetraThyraWrappers_UnitTests.cpp.
References dumpAll, Teuchos::UnitTestRepository::getCLP(), runLinearOpTester, Teuchos::CommandLineProcessor::setOption(), and showAllTests.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| convertTpetraToThyraComm | , | ||
| Scalar | |||
| ) | 
Definition at line 210 of file TpetraThyraWrappers_UnitTests.cpp.
References convertTpetraToThyraComm(), Teuchos::DefaultComm< class >::getComm(), nonnull(), and TEST_ASSERT.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| createVectorSpace | , | ||
| Scalar | |||
| ) | 
Definition at line 223 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, nonnull(), TEST_ASSERT, and TEST_EQUALITY.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| createVector | , | ||
| Scalar | |||
| ) | 
Definition at line 246 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), createVector(), g_localDim, rcp(), TEST_ASSERT, TEST_EQUALITY, and TEST_INEQUALITY.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| createConstVector | , | ||
| Scalar | |||
| ) | 
Definition at line 283 of file TpetraThyraWrappers_UnitTests.cpp.
References createConstVector(), createTpetraMap(), g_localDim, rcp(), TEST_ASSERT, TEST_EQUALITY, and TEST_INEQUALITY.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| createMultiVector | , | ||
| Scalar | |||
| ) | 
Definition at line 322 of file TpetraThyraWrappers_UnitTests.cpp.
References createMultiVector(), createTpetraMap(), g_localDim, rcp(), TEST_ASSERT, TEST_EQUALITY, and TEST_INEQUALITY.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| createConstMultiVector | , | ||
| Scalar | |||
| ) | 
Definition at line 374 of file TpetraThyraWrappers_UnitTests.cpp.
References createConstMultiVector(), createTpetraMap(), g_localDim, rcp(), TEST_ASSERT, TEST_EQUALITY, and TEST_INEQUALITY.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| TeptraVectorSpace | , | ||
| Scalar | |||
| ) | 
Definition at line 427 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, nonnull(), TEST_ASSERT, and TEST_EQUALITY.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| vectorSpaceTester | , | ||
| Scalar | |||
| ) | 
Definition at line 442 of file TpetraThyraWrappers_UnitTests.cpp.
References dumpAll, g_localDim, showAllTests, and TEST_ASSERT.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| vectorStdOpsTester | , | ||
| Scalar | |||
| ) | 
Definition at line 459 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, and TEST_ASSERT.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| multiVectorStdOpsTester | , | ||
| Scalar | |||
| ) | 
Definition at line 476 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, and TEST_ASSERT.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| getTpetraMultiVector | , | ||
| Scalar | |||
| ) | 
Definition at line 492 of file TpetraThyraWrappers_UnitTests.cpp.
References g_localDim, nonnull(), TEST_ASSERT, TEST_EQUALITY, and TEST_THROW.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| getConstTpetraMultiVector | , | ||
| Scalar | |||
| ) | 
Definition at line 529 of file TpetraThyraWrappers_UnitTests.cpp.
References g_localDim, nonnull(), TEST_ASSERT, TEST_EQUALITY, and TEST_THROW.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| TpetraLinearOp | , | ||
| Scalar | |||
| ) | 
Definition at line 566 of file TpetraThyraWrappers_UnitTests.cpp.
References Teuchos::as(), dumpAll, g_localDim, nonnull(), Teuchos::RCP< T >::ptr(), runLinearOpTester, showAllTests, TEST_ASSERT, TEST_FLOATING_EQUALITY, and Teuchos::VERB_HIGH.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| createLinearOp | , | ||
| Scalar | |||
| ) | 
Definition at line 610 of file TpetraThyraWrappers_UnitTests.cpp.
References createLinearOp(), g_localDim, TEST_ASSERT, TEST_EQUALITY, TEST_INEQUALITY, and Teuchos::VERB_HIGH.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| createConstLinearOp | , | ||
| Scalar | |||
| ) | 
Definition at line 655 of file TpetraThyraWrappers_UnitTests.cpp.
References createConstLinearOp(), g_localDim, TEST_ASSERT, TEST_EQUALITY, TEST_INEQUALITY, and Teuchos::VERB_HIGH.
| Teuchos::RCP<Teuchos::Time> Thyra::lookupAndAssertTimer | ( | const std::string & | label | ) | 
Definition at line 701 of file TpetraThyraWrappers_UnitTests.cpp.
References Teuchos::TimeMonitor::lookupCounter(), and TEUCHOS_TEST_FOR_EXCEPTION.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| UseTpetraImplementations | , | ||
| Scalar | |||
| ) | 
Definition at line 724 of file TpetraThyraWrappers_UnitTests.cpp.
References CHECK_TPETRA_FUNC_CALL_INCREMENT, and g_localDim.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| TpetraLinearOp_EpetraRowMatrix | , | ||
| Scalar | |||
| ) | 
Definition at line 899 of file TpetraThyraWrappers_UnitTests.cpp.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| TpetraLinearOp_RowStatLinearOpBase | , | ||
| Scalar | |||
| ) | 
Definition at line 904 of file TpetraThyraWrappers_UnitTests.cpp.
References Teuchos::as(), Teuchos::ScalarTraits< T >::eps(), g_localDim, nonnull(), TEST_ASSERT, TEST_FLOATING_EQUALITY, and Teuchos::VERB_HIGH.
| Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , | 
| TpetraLinearOp_ScaledLinearOpBase | , | ||
| Scalar | |||
| ) | 
Definition at line 956 of file TpetraThyraWrappers_UnitTests.cpp.
References Teuchos::ScalarTraits< T >::eps(), g_localDim, nonnull(), TEST_ASSERT, TEST_FLOATING_EQUALITY, TEUCHOS_ASSERT, and Teuchos::VERB_HIGH.
| const int Thyra::g_localDim = 4 | 
Definition at line 82 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by createTpetraVectorSpace(), TEUCHOS_UNIT_TEST(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| bool Thyra::showAllTests = false | 
Definition at line 185 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by TEUCHOS_STATIC_SETUP(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| bool Thyra::dumpAll = false | 
Definition at line 186 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by main(), TEUCHOS_STATIC_SETUP(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
| bool Thyra::runLinearOpTester = true | 
Definition at line 187 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by TEUCHOS_STATIC_SETUP(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
 1.8.5