Tpetra parallel linear algebra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
File List
Here is a list of all documented files with brief descriptions:
o*Epetra_TsqrAdaptor.hppEpetra_MultiVector to TSQR adaptor
o*Epetra_TsqrMessenger.cppImplementation of a function for wrapping Epetra_Comm in a communicator wrapper that TSQR can use
o*Epetra_TsqrMessenger.hppFunction for wrapping Epetra_Comm in a communicator wrapper that TSQR can use
o*MatrixMarket_Tpetra.cpp
o*MatrixMarket_Tpetra.hppMatrix Market file readers and writers for Tpetra objects
o*MatrixMarket_TpetraNew.hpp
o*MurmurHash3.cpp
o*MurmurHash3.hpp
o*Tpetra_Access.hpp
o*Tpetra_Apply_Helpers.hpp
o*Tpetra_applyDirichletBoundaryCondition.hppDeclare and define Tpetra::applyDirichletBoundaryConditionToLocalMatrixRows
o*Tpetra_ApplyOp.hppImplementation of the class Tpetra::ApplyOp
o*Tpetra_Assembly_Helpers.hpp
o*Tpetra_BlockCrsMatrix_decl.hppDeclaration of Tpetra::BlockCrsMatrix
o*Tpetra_BlockCrsMatrix_def.hppDefinition of Tpetra::BlockCrsMatrix
o*Tpetra_BlockCrsMatrix_fwd.hppForward declaration of Tpetra::BlockCrsMatrix
o*Tpetra_BlockCrsMatrix_Helpers_decl.hpp
o*Tpetra_BlockCrsMatrix_Helpers_def.hpp
o*Tpetra_BlockMultiVector_decl.hpp
o*Tpetra_BlockMultiVector_def.hpp
o*Tpetra_BlockMultiVector_fwd.hppForward declaration of Tpetra::BlockMultiVector
o*Tpetra_BlockVector_decl.hpp
o*Tpetra_BlockVector_def.hpp
o*Tpetra_BlockVector_fwd.hppForward declaration of Tpetra::BlockVector
o*Tpetra_BlockView.hppLinear algebra kernels for small dense matrices and vectors
o*Tpetra_CombineMode.cpp
o*Tpetra_CombineMode.hppDeclaration of Tpetra::CombineMode enum, and a function for setting a Tpetra::CombineMode parameter in a Teuchos::ParameterList
o*Tpetra_ComputeGatherMap.hppFrom a distributed map build a map with all GIDs on the root node
o*Tpetra_computeRowAndColumnOneNorms_decl.hppDeclaration of Tpetra::computeRowAndColumnOneNorms
o*Tpetra_computeRowAndColumnOneNorms_def.hppDefinition of Tpetra::computeRowAndColumnOneNorms
o*Tpetra_ConfigDefs.hpp
o*Tpetra_Core.cpp
o*Tpetra_Core.hppFunctions for initializing and finalizing Tpetra
o*Tpetra_createMeshMap.cpp
o*Tpetra_CrsGraph_decl.hppDeclaration of the Tpetra::CrsGraph class
o*Tpetra_CrsGraph_def.hppDefinition of the Tpetra::CrsGraph class
o*Tpetra_CrsGraph_fwd.hppForward declaration of Tpetra::CrsGraph
o*Tpetra_CrsGraphTransposer_decl.hpp
o*Tpetra_CrsGraphTransposer_def.hpp
o*Tpetra_CrsGraphTransposer_fwd.hppForward declaration of Tpetra::CrsGraphTransposer
o*Tpetra_CrsMatrix_convert.cpp
o*Tpetra_CrsMatrix_decl.hppDeclaration of the Tpetra::CrsMatrix class
o*Tpetra_CrsMatrix_def.hppDefinition of the Tpetra::CrsMatrix class
o*Tpetra_CrsMatrix_fwd.hppForward declaration of Tpetra::CrsMatrix
o*Tpetra_CrsMatrixMultiplyOp.hpp
o*Tpetra_CrsMatrixMultiplyOp_fwd.hppForward declaration of Tpetra::CrsMatrixMultiplyOp
o*Tpetra_Details_allReduceView.hppAll-reduce a 1-D or 2-D Kokkos::View
o*Tpetra_Details_Behavior.cpp
o*Tpetra_Details_Behavior.hppDeclaration of Tpetra::Details::Behavior, a class that describes Tpetra's behavior
o*Tpetra_Details_Blas.hppType traits for Tpetra's BLAS wrappers; an implementation detail of Tpetra::MultiVector
o*Tpetra_Details_castAwayConstDualView.hppDeclaration and definition of Tpetra::Details::castAwayConstDualView, an implementation detail of Tpetra
o*Tpetra_Details_checkGlobalError.cpp
o*Tpetra_Details_checkGlobalError.hpp
o*Tpetra_Details_checkLaunchBlocking.hpp
o*Tpetra_Details_checkView.hppDeclaration of functions for checking whether a given pointer is accessible from a given Kokkos execution space
o*Tpetra_Details_computeOffsets.hppDeclare and define the functions Tpetra::Details::computeOffsetsFromCounts and Tpetra::computeOffsetsFromConstantCount. These functions are implementation details of Tpetra (in particular, of FixedHashTable, CrsGraph, and CrsMatrix)
o*Tpetra_Details_CooMatrix.hppDeclaration and definition of Tpetra::Details::CooMatrix, an implementation detail of Tpetra::CrsMatrix (sparse matrix) file input and output
o*Tpetra_Details_copyConvert.hppDeclare and define Tpetra::Details::copyConvert, an implementation detail of Tpetra (in particular, of FixedHashTable, CrsGraph, and CrsMatrix)
o*Tpetra_Details_copyOffsets.hppDeclare and define Tpetra::Details::copyOffsets, an implementation detail of Tpetra (in particular, of FixedHashTable, CrsGraph, and CrsMatrix)
o*Tpetra_Details_createMirrorView.hppFunctions that wrap Kokkos::create_mirror_view, in order to avoid deep copies when not necessary, even if the inputs are const
o*Tpetra_Details_crsMatrixAssembleElement.hpp
o*Tpetra_Details_CrsPadding.hpp
o*Tpetra_Details_crsUtils.hppFunctions for manipulating CRS arrays
o*Tpetra_Details_DeepCopyCounter.cpp
o*Tpetra_Details_DeepCopyCounter.hppDeclaration of Tpetra::Details::DeepCopyCounter, a class that uses Kokkos' profiling library to count deep copies between memory spaces
o*Tpetra_Details_DeepCopyTeuchosTimerInjection.cpp
o*Tpetra_Details_DeepCopyTeuchosTimerInjection.hppDeclaration of Tpetra::Details::DeepCopyTeuchosTimerInjection, a class that uses Kokkos' profiling library to add deep copies between memory spaces to the Teuchos::TimeMonitor system. The idea being that you enable this capability and your regular timer output now prints out all of your traffic between memory spaces. This does have the side effect of making Kokkos::deep_copy() calls on the host also call Kokkos::fence()
o*Tpetra_Details_DefaultTypes.hpp
o*Tpetra_Details_determineLocalTriangularStructure.hppDeclaration and definition of Tpetra::Details::determineLocalTriangularStructure
o*Tpetra_Details_DistributorActor.cpp
o*Tpetra_Details_DistributorActor.hpp
o*Tpetra_Details_DistributorPlan.cpp
o*Tpetra_Details_DistributorPlan.hpp
o*Tpetra_Details_DualViewUtil.cpp
o*Tpetra_Details_DualViewUtil.hpp
o*Tpetra_Details_EquilibrationInfo.hppDeclaration of Tpetra::Details::EquilibrationInfo
o*Tpetra_Details_ExecutionSpaces.cpp
o*Tpetra_Details_ExecutionSpaces.hpp
o*Tpetra_Details_ExecutionSpacesSlot.hpp
o*Tpetra_Details_ExecutionSpacesUser.hpp
o*Tpetra_Details_extractBlockDiagonal.hppFunctions that allow for the extraction of a block diagonal from a Tpetra::CrsMatrix
o*Tpetra_Details_extractMpiCommFromTeuchos.cpp
o*Tpetra_Details_extractMpiCommFromTeuchos.hppDeclaration of Tpetra::Details::extractMpiCommFromTeuchos
o*Tpetra_Details_fill.cpp
o*Tpetra_Details_fill.hppDeclaration and definition of Tpetra::Details::Blas::fill, an implementation detail of Tpetra::MultiVector
o*Tpetra_Details_FixedHashTable_Cuda.cpp
o*Tpetra_Details_FixedHashTable_decl.hpp
o*Tpetra_Details_FixedHashTable_def.hpp
o*Tpetra_Details_FixedHashTable_HIP.cpp
o*Tpetra_Details_FixedHashTable_OpenMP.cpp
o*Tpetra_Details_FixedHashTable_Serial.cpp
o*Tpetra_Details_FixedHashTable_SYCL.cpp
o*Tpetra_Details_FixedHashTable_Threads.cpp
o*Tpetra_Details_gathervPrint.cpp
o*Tpetra_Details_gathervPrint.hppDeclaration of a function that prints strings from each process
o*Tpetra_Details_get1DConstView.hppCreate a Kokkos::View from a raw host array
o*Tpetra_Details_getDiagCopyWithoutOffsets_decl.hppDeclaration and definition of Tpetra::Details::getDiagCopyWithoutOffsets, and declaration (only) of Tpetra::Details::getDiagCopyWithoutOffsetsNotFillcomplete
o*Tpetra_Details_getDiagCopyWithoutOffsets_def.hppDefinition of Tpetra::Details::getDiagCopyWithoutOffsetsNotFillComplete (an implementation detail of Tpetra::CrsMatrix)
o*Tpetra_Details_getEntryOnHost.hppDeclaration and definition of Tpetra::Details::getEntryOnHost
o*Tpetra_Details_getGraphDiagOffsets.cpp
o*Tpetra_Details_getGraphDiagOffsets_decl.hppDeclare and define the function Tpetra::Details::getGraphDiagOffsets, an implementation detail of Tpetra::CrsGraph
o*Tpetra_Details_getGraphDiagOffsets_def.hppDefine the implementation of the function Tpetra::Details::getGraphDiagOffsets, an implementation detail of Tpetra::CrsGraph
o*Tpetra_Details_getGraphOffRankOffsets.cpp
o*Tpetra_Details_getGraphOffRankOffsets_decl.hppDeclare and define the function Tpetra::Details::getGraphOffRankOffsets, an implementation detail of Tpetra::CrsGraph
o*Tpetra_Details_getGraphOffRankOffsets_def.hppDefine the implementation of the function Tpetra::Details::getGraphOffRankOffsets, an implementation detail of Tpetra::CrsGraph
o*Tpetra_Details_getNumDiags.hppDeclaration and definition of getLocalNumDiags and getGlobalNumDiags
o*Tpetra_Details_Hash.cpp
o*Tpetra_Details_Hash.hpp
o*Tpetra_Details_iallreduce.cpp
o*Tpetra_Details_iallreduce.hppDeclaration of Tpetra::Details::iallreduce
o*Tpetra_Details_initializeKokkos.cpp
o*Tpetra_Details_initializeKokkos.hppDeclaration of Tpetra::Details::initializeKokkos
o*Tpetra_Details_isInterComm.cpp
o*Tpetra_Details_isInterComm.hppDeclaration of Tpetra::Details::isInterComm
o*Tpetra_Details_lclDot.hppDeclaration and definition of Tpetra::Details::lclDot, an implementation detail of Tpetra::MultiVector
o*Tpetra_Details_leftScaleLocalCrsMatrix.hppDeclaration and definition of Tpetra::Details::leftScaleLocalCrsMatrix
o*Tpetra_Details_LocalMap.hppDeclaration and definition of the Tpetra::Map class, an implementation detail of Tpetra::Map
o*Tpetra_Details_LocalMap_fwd.hppForward declaration of Tpetra::Details::LocalMap
o*Tpetra_Details_makeColMap_decl.hppDeclaration of Tpetra::Details::makeColMap, a function for creating the column Map of a Tpetra::CrsGraph
o*Tpetra_Details_makeColMap_def.hppDefinition of Tpetra::Details::makeColMap, a function for creating the column Map of a Tpetra::CrsGraph
o*Tpetra_Details_makeOptimizedColMap.hppOptimize your graph's or matrix's column Map for better communication performance
o*Tpetra_Details_makeValidVerboseStream.cpp
o*Tpetra_Details_makeValidVerboseStream.hpp
o*Tpetra_Details_Merge.hpp
o*Tpetra_Details_mpiIsInitialized.cpp
o*Tpetra_Details_mpiIsInitialized.hpp
o*Tpetra_Details_MpiTypeTraits.cpp
o*Tpetra_Details_MpiTypeTraits.hppAdd specializations of Teuchos::Details::MpiTypeTraits for Kokkos::complex<float> and Kokkos::complex<double>, and import Teuchos::Details::MpiTypeTraits into the Tpetra::Details namespace
o*Tpetra_Details_normImpl.hppDeclaration and definition of Tpetra::Details::normImpl, which is an implementation detail of Tpetra::MultiVector
o*Tpetra_Details_OrdinalTraits.hppImport KokkosSparse::OrdinalTraits, a traits class for "invalid" (flag) values of integer types, into the Tpetra::Details namespace
o*Tpetra_Details_packCrsGraph_decl.hppFunctions for packing the entries of a Tpetra::CrsGraph for communication, in the case where it is valid to go to the KokkosSparse::CrsGraph (local sparse graph data structure) directly
o*Tpetra_Details_packCrsGraph_def.hppFunctions for packing the entries of a Tpetra::CrsGraph for communication, in the case where it is valid to go to the KokkosSparse::CrsGraph (local sparse graph data structure) directly
o*Tpetra_Details_packCrsMatrix_decl.hppFunctions for packing the entries of a Tpetra::CrsMatrix for communication, in the case where it is valid to go to the KokkosSparse::CrsMatrix (local sparse matrix data structure) directly
o*Tpetra_Details_packCrsMatrix_def.hppFunctions for packing the entries of a Tpetra::CrsMatrix for communication, in the case where it is valid to go to the KokkosSparse::CrsMatrix (local sparse matrix data structure) directly
o*Tpetra_Details_PackTraits.hppDeclaration and generic definition of traits class that tells Tpetra::CrsMatrix how to pack and unpack data
o*Tpetra_Details_PackTriples.cpp
o*Tpetra_Details_PackTriples.hpp
o*Tpetra_Details_printOnce.cpp
o*Tpetra_Details_printOnce.hppDeclaration of Tpetra::Details::printOnce
o*Tpetra_Details_Profiling.cpp
o*Tpetra_Details_Profiling.hppDeclaration of Tpetra::Details::Profiling, a scope guard for Kokkos Profiling
o*Tpetra_Details_radixSort.hpp
o*Tpetra_Details_ReadTriples.hppDeclaration and definition of Tpetra::Details::readAndDealOutTriples, which reads a Matrix Market file or input stream on one process, and distributes the resulting sparse matrix entries to the other processes
o*Tpetra_Details_reallocDualViewIfNeeded.hppDeclaration and definition of Tpetra::Details::reallocDualViewIfNeeded, an implementation detail of Tpetra
o*Tpetra_Details_residual.hppFunctions that allow for fused residual calculation
o*Tpetra_Details_rightScaleLocalCrsMatrix.hppDeclaration and definition of Tpetra::Details::rightScaleLocalCrsMatrix
o*Tpetra_Details_ScalarViewTraits.hppDeclaration and generic definition of traits class that tells Tpetra::CrsMatrix how to pack and unpack data
o*Tpetra_Details_scaleBlockDiagonal.hppFunctions that rescales a multivector (in-place) by a inverse of a block-diagonal matrix (as implied by the given MultiVector) or its transpose
o*Tpetra_Details_shortSort.hppDeclaration and definition of functions for sorting "short" arrays of keys and corresponding values
o*Tpetra_Details_StaticView.cpp
o*Tpetra_Details_StaticView.hpp
o*Tpetra_Details_temporaryViewUtils.hpp
o*Tpetra_Details_Transfer.cpp
o*Tpetra_Details_Transfer_decl.hpp
o*Tpetra_Details_Transfer_def.hpp
o*Tpetra_Details_Transfer_fwd.hppForward declaration of Tpetra::Details::Transfer
o*Tpetra_Details_unpackCrsGraphAndCombine_decl.hppDeclaration of functions for unpacking the entries of a Tpetra::CrsGraph for communication, in the case where it is valid to go to the KokkosSparse::CrsGraph (local sparse graph data structure) directly
o*Tpetra_Details_unpackCrsGraphAndCombine_def.hppDefinition of functions for unpacking the entries of a Tpetra::CrsGraph for communication, in the case where it is valid to go to the KokkosSparse::CrsGraph (local sparse graph data structure) directly
o*Tpetra_Details_unpackCrsMatrixAndCombine_decl.hppDeclaration of functions for unpacking the entries of a Tpetra::CrsMatrix for communication, in the case where it is valid to go to the KokkosSparse::CrsMatrix (local sparse matrix data structure) directly
o*Tpetra_Details_unpackCrsMatrixAndCombine_def.hppDefinition of functions for unpacking the entries of a Tpetra::CrsMatrix for communication, in the case where it is valid to go to the KokkosSparse::CrsMatrix (local sparse matrix data structure) directly
o*Tpetra_Details_WrappedDualView.cpp
o*Tpetra_Details_WrappedDualView.hpp
o*Tpetra_Directory_decl.hpp
o*Tpetra_Directory_def.hpp
o*Tpetra_Directory_fwd.hppForward declaration of Tpetra::Directory
o*Tpetra_DirectoryImpl_decl.hppDeclaration of implementation details of Tpetra::Directory
o*Tpetra_DirectoryImpl_def.hppDefinition of implementation details of Tpetra::Directory
o*Tpetra_DistObject_decl.hppDeclaration of the Tpetra::DistObject class
o*Tpetra_DistObject_def.hppDefinition of the Tpetra::DistObject class
o*Tpetra_DistObject_fwd.hppForward declaration of Tpetra::DistObject
o*Tpetra_Distribution.hpp
o*Tpetra_Distribution1D.hpp
o*Tpetra_Distribution2D.hpp
o*Tpetra_DistributionLowerTriangularBlock.hpp
o*Tpetra_DistributionMM.hpp
o*Tpetra_Distributor.cpp
o*Tpetra_Distributor.hpp
o*Tpetra_EpetraRowMatrix.cpp
o*Tpetra_EpetraRowMatrix.hpp
o*Tpetra_Exceptions.cpp
o*Tpetra_Exceptions_decl.hppDeclarations of Tpetra-specific exceptions
o*Tpetra_Exceptions_def.hpp
o*Tpetra_Export_decl.hpp
o*Tpetra_Export_def.hpp
o*Tpetra_Export_fwd.hppForward declaration of Tpetra::Export
o*Tpetra_FECrsGraph_decl.hppDeclaration of the Tpetra::FECrsGraph class
o*Tpetra_FECrsGraph_def.hpp
o*Tpetra_FECrsGraph_fwd.hppForward declaration of Tpetra::FECrsGraph
o*Tpetra_FECrsMatrix_decl.hppDeclaration of the Tpetra::FECrsMatrix class
o*Tpetra_FECrsMatrix_def.hpp
o*Tpetra_FECrsMatrix_fwd.hppForward declaration of Tpetra::FECrsMatrix
o*Tpetra_FEMultiVector_decl.hppDeclaration of the Tpetra::MultiVector class
o*Tpetra_FEMultiVector_def.hpp
o*Tpetra_FEMultiVector_fwd.hppForward declaration of Tpetra::FEMultiVector
o*Tpetra_HashTable.cpp
o*Tpetra_HashTable_decl.hpp
o*Tpetra_HashTable_def.hpp
o*Tpetra_iallreduce.hppDeclaration of Tpetra::iallreduce
o*Tpetra_idot.hppDeclaration of Tpetra::idot, a nonblocking dot product
o*Tpetra_Import_decl.hpp
o*Tpetra_Import_def.hpp
o*Tpetra_Import_fwd.hppForward declaration of Tpetra::Import
o*Tpetra_Import_Util.hppInternal functions and macros designed for use with Tpetra::Import and Tpetra::Export objects
o*Tpetra_Import_Util2.hppUtility functions for packing and unpacking sparse matrix entries
o*Tpetra_ImportExportData_decl.hpp
o*Tpetra_ImportExportData_def.hpp
o*Tpetra_ImportExportData_fwd.hppForward declaration of Tpetra::ImportExportData
o*Tpetra_KokkosRefactor_Details_MultiVectorDistObjectKernels.hpp
o*Tpetra_KokkosRefactor_Details_MultiVectorLocalDeepCopy.hpp
o*Tpetra_leftAndOrRightScaleCrsMatrix_decl.hppDeclaration of Tpetra::leftAndOrRightScaleCrsMatrix
o*Tpetra_leftAndOrRightScaleCrsMatrix_def.hppDefinition of Tpetra::leftAndOrRightScaleCrsMatrix
o*Tpetra_LocalCrsMatrixOperator_decl.hpp
o*Tpetra_LocalCrsMatrixOperator_def.hpp
o*Tpetra_LocalCrsMatrixOperator_fwd.hpp
o*Tpetra_LocalOperator.hpp
o*Tpetra_LocalOperator_fwd.hppForward declaration of Tpetra::LocalCrsMatrixOperator
o*Tpetra_Map.cpp
o*Tpetra_Map_decl.hppDeclaration of the Tpetra::Map class and related nonmember constructors
o*Tpetra_Map_def.hpp
o*Tpetra_Map_fwd.hppForward declaration of Tpetra::Map
o*Tpetra_MatrixIO.cpp
o*Tpetra_MatrixIO_decl.hppDeclarations of functions to read a Tpetra::CrsMatrix sparse matrix from a Harwell-Boeing file
o*Tpetra_MatrixIO_def.hpp
o*Tpetra_MixedScalarMultiplyOp.hpp
o*Tpetra_MultiVector_decl.hppDeclaration of the Tpetra::MultiVector class
o*Tpetra_MultiVector_def.hppDefinition of the Tpetra::MultiVector class
o*Tpetra_MultiVector_fwd.hppForward declaration of Tpetra::MultiVector
o*Tpetra_Operator.hpp
o*Tpetra_Operator_fwd.hppForward declaration of Tpetra::Operator
o*Tpetra_Packable.hppDeclaration of Tpetra::Packable
o*Tpetra_Packable_fwd.hppForward declaration of Tpetra::Packable
o*Tpetra_replaceDiagonalCrsMatrix_decl.hppDeclaration of Tpetra::replaceDiagonalCrsMatrix
o*Tpetra_replaceDiagonalCrsMatrix_def.hppDefinition of Tpetra::repalceDiagonalCrsMatrix
o*Tpetra_RowGraph.cpp
o*Tpetra_RowGraph_decl.hpp
o*Tpetra_RowGraph_def.hpp
o*Tpetra_RowGraph_fwd.hppForward declaration of Tpetra::RowGraph
o*Tpetra_RowMatrix_decl.hpp
o*Tpetra_RowMatrix_def.hpp
o*Tpetra_RowMatrix_fwd.hppForward declaration of Tpetra::RowMatrix
o*Tpetra_RowMatrixTransposer_decl.hpp
o*Tpetra_RowMatrixTransposer_def.hpp
o*Tpetra_RowMatrixTransposer_fwd.hppForward declaration of Tpetra::RowMatrixTransposer
o*Tpetra_SrcDistObject.hppAbstract base class for sources of an Import or Export
o*Tpetra_TieBreak.hppInterface for breaking ties in ownership
o*Tpetra_TieBreak_fwd.hppForward declaration for Tpetra::TieBreak
o*Tpetra_TsqrAdaptor.hppAdaptor from Tpetra::MultiVector to TSQR
o*Tpetra_Util.cpp
o*Tpetra_Util.hppStand-alone utility functions and macros
o*Tpetra_Vector_decl.hppDeclaration of the Tpetra::Vector class
o*Tpetra_Vector_def.hppDefinition of the Tpetra::Vector class
o*Tpetra_Vector_fwd.hppForward declaration of Tpetra::Vector
o*Tpetra_Version.cpp
o*Tpetra_Version.hpp
o*TpetraExt_MatrixMatrix.cpp
o*TpetraExt_MatrixMatrix_Cuda.hpp
o*TpetraExt_MatrixMatrix_decl.hpp
o*TpetraExt_MatrixMatrix_def.hpp
o*TpetraExt_MatrixMatrix_ExtraKernels_decl.hpp
o*TpetraExt_MatrixMatrix_ExtraKernels_def.hpp
o*TpetraExt_MatrixMatrix_HIP.hpp
o*TpetraExt_MatrixMatrix_OpenMP.hpp
o*TpetraExt_MatrixMatrix_SYCL.hpp
o*TpetraExt_MMHelpers.cpp
o*TpetraExt_MMHelpers_decl.hppDeclaration of Tpetra::MMMultiMultiply and nonmember constructors
o*TpetraExt_MMHelpers_def.hpp
o*TpetraExt_TripleMatrixMultiply.cpp
o*TpetraExt_TripleMatrixMultiply_decl.hpp
\*TpetraExt_TripleMatrixMultiply_def.hpp