Thyra Package Browser (Single Doxygen Collection) Version of the Day
|
Classes | |
class | CopyTpetraMultiVectorViewBack |
class | DiagonalEpetraLinearOpWithSolveFactory |
Create a DefaultDiagonalLinearOpWithSolve out of a diagonal Epetra_RowMatrix 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 | 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 | EpetraModelEvaluator |
Concrete Adapter subclass that takes an EpetraExt::ModelEvaluator object and wraps it as a Thyra::ModelEvaluator object. 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 | TpetraEuclideanScalarProd |
Extends concrete implementation of a Euclidean scalar product for specifically Tpetra vectors/multivectors. More... | |
class | TpetraExplicitAdjointModelEvaluator |
A model evaluator decorator for computing an explicit adjoint. 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... | |
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... | |
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(), Teuchos::RCP< class 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(), Teuchos::RCP< class 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(), Teuchos::RCP< class 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(), Teuchos::RCP< class 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(), Teuchos::RCP< class 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.
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.
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.
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.
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraOperatorWrapper | , |
basic | ) |
Definition at line 83 of file EpetraOperatorWrapper_UnitTests.cpp.
References Teuchos::RCP< class T >::ptr(), and TEUCHOS_UNIT_TEST().
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , |
ScaledLinearOpBase | ) |
Definition at line 85 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, Teuchos::RCP< class T >::ptr(), TEST_FLOATING_EQUALITY, TEUCHOS_UNIT_TEST(), and Teuchos::updateSuccess().
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , |
RowStatLinearOpBase | ) |
Definition at line 251 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, Teuchos::RCP< class T >::ptr(), TEST_FLOATING_EQUALITY, TEUCHOS_UNIT_TEST(), 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(), and TEUCHOS_UNIT_TEST().
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , |
Blocked_ScaledLinearOpBase | ) |
Definition at line 335 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, getMyEpetraMatrix(), Teuchos::RCP< class T >::ptr(), TEUCHOS_UNIT_TEST(), and Teuchos::updateSuccess().
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , |
Blocked_RowStatLinearOpBase | ) |
Definition at line 418 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, Teuchos::RCP< class T >::ptr(), TEST_FLOATING_EQUALITY, TEUCHOS_UNIT_TEST(), and Teuchos::updateSuccess().
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , |
Blocked_ScalingWithMultiVectors | ) |
Definition at line 487 of file EpetraLinearOp_UnitTests.cpp.
References Teuchos::DefaultComm< typename OrdinalType >::getComm(), getMyEpetraMatrix(), Teuchos::RCP< class T >::ptr(), TEST_FLOATING_EQUALITY, TEUCHOS_UNIT_TEST(), Teuchos::updateSuccess(), and Teuchos::VERB_EXTREME.
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , |
rectangular | ) |
Definition at line 606 of file EpetraLinearOp_UnitTests.cpp.
References g_localDim, TEUCHOS_UNIT_TEST(), and Teuchos::updateSuccess().
Thyra::TEUCHOS_UNIT_TEST | ( | EpetraLinearOp | , |
blocked_op | ) |
Definition at line 635 of file EpetraLinearOp_UnitTests.cpp.
References Teuchos::GlobalMPISession::getNProc(), Teuchos::RCP< class T >::ptr(), TEUCHOS_UNIT_TEST(), 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_UNIT_TEST(), and 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 convert(), and Teuchos::RCP< class T >::get().
Referenced by convert().
RCP< TpetraExplicitAdjointModelEvaluator< Scalar > > Thyra::tpetraExplicitAdjointModelEvaluator | ( | const RCP< const ModelEvaluator< Scalar > > & | model | ) |
Definition at line 174 of file Thyra_TpetraExplicitAdjointModelEvaluator.hpp.
References Teuchos::rcp().
RCP< TpetraExplicitAdjointModelEvaluator< Scalar > > Thyra::tpetraExplicitAdjointModelEvaluator | ( | const RCP< ModelEvaluator< Scalar > > & | model | ) |
Definition at line 182 of file Thyra_TpetraExplicitAdjointModelEvaluator.hpp.
References Teuchos::rcp().
|
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, Teuchos::NO_TRANS, TEUCHOS_TEST_FOR_EXCEPT, and Teuchos::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.
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.
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.
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(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), 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, runLinearOpTester, 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< typename OrdinalType >::getComm(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
createVectorSpace | , | ||
Scalar | ) |
Definition at line 223 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
createVector | , | ||
Scalar | ) |
Definition at line 246 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), createVector(), g_localDim, TEST_INEQUALITY, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
createConstVector | , | ||
Scalar | ) |
Definition at line 283 of file TpetraThyraWrappers_UnitTests.cpp.
References createConstVector(), createTpetraMap(), g_localDim, TEST_INEQUALITY, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
createMultiVector | , | ||
Scalar | ) |
Definition at line 322 of file TpetraThyraWrappers_UnitTests.cpp.
References createMultiVector(), createTpetraMap(), g_localDim, TEST_INEQUALITY, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
createConstMultiVector | , | ||
Scalar | ) |
Definition at line 374 of file TpetraThyraWrappers_UnitTests.cpp.
References createConstMultiVector(), createTpetraMap(), g_localDim, TEST_INEQUALITY, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
TeptraVectorSpace | , | ||
Scalar | ) |
Definition at line 427 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
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 TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
vectorStdOpsTester | , | ||
Scalar | ) |
Definition at line 459 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
multiVectorStdOpsTester | , | ||
Scalar | ) |
Definition at line 476 of file TpetraThyraWrappers_UnitTests.cpp.
References createTpetraMap(), g_localDim, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
getTpetraMultiVector | , | ||
Scalar | ) |
Definition at line 492 of file TpetraThyraWrappers_UnitTests.cpp.
References g_localDim, TEST_THROW, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
getConstTpetraMultiVector | , | ||
Scalar | ) |
Definition at line 529 of file TpetraThyraWrappers_UnitTests.cpp.
References g_localDim, TEST_THROW, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
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, Teuchos::RCP< class T >::ptr(), runLinearOpTester, showAllTests, TEST_FLOATING_EQUALITY, TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), 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_INEQUALITY, TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), 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_INEQUALITY, TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), 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::PerformanceMonitorBase< Time >::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, g_localDim, and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
TpetraLinearOp_EpetraRowMatrix | , | ||
Scalar | ) |
Definition at line 899 of file TpetraThyraWrappers_UnitTests.cpp.
References TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Thyra::TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL | ( | TpetraThyraWrappers | , |
TpetraLinearOp_RowStatLinearOpBase | , | ||
Scalar | ) |
Definition at line 904 of file TpetraThyraWrappers_UnitTests.cpp.
References Teuchos::as(), g_localDim, Teuchos::RCP< class T >::ptr(), TEST_FLOATING_EQUALITY, TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), 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 g_localDim, Teuchos::RCP< class T >::ptr(), TEST_FLOATING_EQUALITY, TEUCHOS_ASSERT, TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), and Teuchos::VERB_HIGH.
Definition at line 82 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by createTpetraVectorSpace(), TEUCHOS_UNIT_TEST(), TEUCHOS_UNIT_TEST(), TEUCHOS_UNIT_TEST(), TEUCHOS_UNIT_TEST(), TEUCHOS_UNIT_TEST(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Definition at line 185 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by TEUCHOS_STATIC_SETUP(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Definition at line 186 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by TEUCHOS_STATIC_SETUP(), TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().
Definition at line 187 of file TpetraThyraWrappers_UnitTests.cpp.
Referenced by TEUCHOS_STATIC_SETUP(), and TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL().