Tpetra parallel linear algebra Version of the Day
Loading...
Searching...
No Matches
src Directory Reference
Directory dependency graph for src:
src

Directories

 kokkos_refactor
 

Files

 Epetra_TsqrAdaptor.hpp
 Epetra_MultiVector to TSQR adaptor.
 
 Epetra_TsqrMessenger.cpp
 Implementation of a function for wrapping Epetra_Comm in a communicator wrapper that TSQR can use.
 
 Epetra_TsqrMessenger.hpp
 Function for wrapping Epetra_Comm in a communicator wrapper that TSQR can use.
 
 MurmurHash3.cpp
 
 MurmurHash3.hpp
 
 Tpetra_Access.hpp
 
 Tpetra_Apply_Helpers.hpp
 
 Tpetra_applyDirichletBoundaryCondition.hpp
 Declare and define Tpetra::applyDirichletBoundaryConditionToLocalMatrixRows.
 
 Tpetra_ApplyOp.hpp
 Implementation of the class Tpetra::ApplyOp.
 
 Tpetra_Assembly_Helpers.hpp
 
 Tpetra_BlockCrsMatrix_decl.hpp
 Declaration of Tpetra::BlockCrsMatrix.
 
 Tpetra_BlockCrsMatrix_def.hpp
 Definition of Tpetra::BlockCrsMatrix.
 
 Tpetra_BlockCrsMatrix_fwd.hpp
 Forward declaration of Tpetra::BlockCrsMatrix.
 
 Tpetra_BlockCrsMatrix_Helpers_decl.hpp
 
 Tpetra_BlockCrsMatrix_Helpers_def.hpp
 
 Tpetra_BlockMultiVector_decl.hpp
 
 Tpetra_BlockMultiVector_def.hpp
 
 Tpetra_BlockMultiVector_fwd.hpp
 Forward declaration of Tpetra::BlockMultiVector.
 
 Tpetra_BlockVector_decl.hpp
 
 Tpetra_BlockVector_def.hpp
 
 Tpetra_BlockVector_fwd.hpp
 Forward declaration of Tpetra::BlockVector.
 
 Tpetra_BlockView.hpp
 Linear algebra kernels for small dense matrices and vectors.
 
 Tpetra_CombineMode.cpp
 
 Tpetra_CombineMode.hpp
 Declaration of Tpetra::CombineMode enum, and a function for setting a Tpetra::CombineMode parameter in a Teuchos::ParameterList.
 
 Tpetra_ComputeGatherMap.hpp
 From a distributed map build a map with all GIDs on the root node.
 
 Tpetra_computeRowAndColumnOneNorms_decl.hpp
 Declaration of Tpetra::computeRowAndColumnOneNorms.
 
 Tpetra_computeRowAndColumnOneNorms_def.hpp
 Definition of Tpetra::computeRowAndColumnOneNorms.
 
 Tpetra_ConfigDefs.hpp
 
 Tpetra_Core.cpp
 
 Tpetra_Core.hpp
 Functions for initializing and finalizing Tpetra.
 
 Tpetra_createMeshMap.cpp
 
 Tpetra_CrsGraph_decl.hpp
 Declaration of the Tpetra::CrsGraph class.
 
 Tpetra_CrsGraph_def.hpp
 Definition of the Tpetra::CrsGraph class.
 
 Tpetra_CrsGraph_fwd.hpp
 Forward declaration of Tpetra::CrsGraph.
 
 Tpetra_CrsGraphTransposer_decl.hpp
 
 Tpetra_CrsGraphTransposer_def.hpp
 
 Tpetra_CrsGraphTransposer_fwd.hpp
 Forward declaration of Tpetra::CrsGraphTransposer.
 
 Tpetra_CrsMatrix_convert.cpp
 
 Tpetra_CrsMatrix_decl.hpp
 Declaration of the Tpetra::CrsMatrix class.
 
 Tpetra_CrsMatrix_def.hpp
 Definition of the Tpetra::CrsMatrix class.
 
 Tpetra_CrsMatrix_fwd.hpp
 Forward declaration of Tpetra::CrsMatrix.
 
 Tpetra_CrsMatrixMultiplyOp.hpp
 
 Tpetra_CrsMatrixMultiplyOp_fwd.hpp
 Forward declaration of Tpetra::CrsMatrixMultiplyOp.
 
 Tpetra_Details_allReduceView.hpp
 All-reduce a 1-D or 2-D Kokkos::View.
 
 Tpetra_Details_Behavior.cpp
 
 Tpetra_Details_Behavior.hpp
 Declaration of Tpetra::Details::Behavior, a class that describes Tpetra's behavior.
 
 Tpetra_Details_Blas.hpp
 Type traits for Tpetra's BLAS wrappers; an implementation detail of Tpetra::MultiVector.
 
 Tpetra_Details_castAwayConstDualView.hpp
 Declaration and definition of Tpetra::Details::castAwayConstDualView, an implementation detail of Tpetra.
 
 Tpetra_Details_checkGlobalError.cpp
 
 Tpetra_Details_checkGlobalError.hpp
 
 Tpetra_Details_checkLaunchBlocking.hpp
 
 Tpetra_Details_checkView.hpp
 Declaration of functions for checking whether a given pointer is accessible from a given Kokkos execution space.
 
 Tpetra_Details_computeOffsets.hpp
 Declare and define the functions Tpetra::Details::computeOffsetsFromCounts and Tpetra::computeOffsetsFromConstantCount. These functions are implementation details of Tpetra (in particular, of FixedHashTable, CrsGraph, and CrsMatrix).
 
 Tpetra_Details_copyConvert.hpp
 Declare and define Tpetra::Details::copyConvert, an implementation detail of Tpetra (in particular, of FixedHashTable, CrsGraph, and CrsMatrix).
 
 Tpetra_Details_copyOffsets.hpp
 Declare and define Tpetra::Details::copyOffsets, an implementation detail of Tpetra (in particular, of FixedHashTable, CrsGraph, and CrsMatrix).
 
 Tpetra_Details_createMirrorView.hpp
 Functions that wrap Kokkos::create_mirror_view, in order to avoid deep copies when not necessary, even if the inputs are const.
 
 Tpetra_Details_crsMatrixAssembleElement.hpp
 
 Tpetra_Details_CrsPadding.hpp
 
 Tpetra_Details_crsUtils.hpp
 Functions for manipulating CRS arrays.
 
 Tpetra_Details_DeepCopyCounter.cpp
 
 Tpetra_Details_DeepCopyCounter.hpp
 Declaration of Tpetra::Details::DeepCopyCounter, a class that uses Kokkos' profiling library to count deep copies between memory spaces.
 
 Tpetra_Details_DefaultTypes.hpp
 
 Tpetra_Details_determineLocalTriangularStructure.hpp
 Declaration and definition of Tpetra::Details::determineLocalTriangularStructure.
 
 Tpetra_Details_DistributorActor.cpp
 
 Tpetra_Details_DistributorActor.hpp
 
 Tpetra_Details_DistributorPlan.cpp
 
 Tpetra_Details_DistributorPlan.hpp
 
 Tpetra_Details_DualViewUtil.cpp
 
 Tpetra_Details_DualViewUtil.hpp
 
 Tpetra_Details_EquilibrationInfo.hpp
 Declaration of Tpetra::Details::EquilibrationInfo.
 
 Tpetra_Details_extractBlockDiagonal.hpp
 Functions that allow for the extraction of a block diagonal from a Tpetra::CrsMatrix.
 
 Tpetra_Details_extractMpiCommFromTeuchos.cpp
 
 Tpetra_Details_extractMpiCommFromTeuchos.hpp
 Declaration of Tpetra::Details::extractMpiCommFromTeuchos.
 
 Tpetra_Details_fill.cpp
 
 Tpetra_Details_fill.hpp
 Declaration and definition of Tpetra::Details::Blas::fill, an implementation detail of Tpetra::MultiVector.
 
 Tpetra_Details_FixedHashTable_Cuda.cpp
 
 Tpetra_Details_FixedHashTable_decl.hpp
 
 Tpetra_Details_FixedHashTable_def.hpp
 
 Tpetra_Details_FixedHashTable_HIP.cpp
 
 Tpetra_Details_FixedHashTable_OpenMP.cpp
 
 Tpetra_Details_FixedHashTable_Serial.cpp
 
 Tpetra_Details_FixedHashTable_SYCL.cpp
 
 Tpetra_Details_FixedHashTable_Threads.cpp
 
 Tpetra_Details_gathervPrint.cpp
 
 Tpetra_Details_gathervPrint.hpp
 Declaration of a function that prints strings from each process.
 
 Tpetra_Details_get1DConstView.hpp
 Create a Kokkos::View from a raw host array.
 
 Tpetra_Details_getDiagCopyWithoutOffsets_decl.hpp
 Declaration and definition of Tpetra::Details::getDiagCopyWithoutOffsets, and declaration (only) of Tpetra::Details::getDiagCopyWithoutOffsetsNotFillcomplete.
 
 Tpetra_Details_getDiagCopyWithoutOffsets_def.hpp
 Definition of Tpetra::Details::getDiagCopyWithoutOffsetsNotFillComplete (an implementation detail of Tpetra::CrsMatrix).
 
 Tpetra_Details_getEntryOnHost.hpp
 Declaration and definition of Tpetra::Details::getEntryOnHost.
 
 Tpetra_Details_getGraphDiagOffsets.cpp
 
 Tpetra_Details_getGraphDiagOffsets_decl.hpp
 Declare and define the function Tpetra::Details::getGraphDiagOffsets, an implementation detail of Tpetra::CrsGraph.
 
 Tpetra_Details_getGraphDiagOffsets_def.hpp
 Define the implementation of the function Tpetra::Details::getGraphDiagOffsets, an implementation detail of Tpetra::CrsGraph.
 
 Tpetra_Details_getGraphOffRankOffsets.cpp
 
 Tpetra_Details_getGraphOffRankOffsets_decl.hpp
 Declare and define the function Tpetra::Details::getGraphOffRankOffsets, an implementation detail of Tpetra::CrsGraph.
 
 Tpetra_Details_getGraphOffRankOffsets_def.hpp
 Define the implementation of the function Tpetra::Details::getGraphOffRankOffsets, an implementation detail of Tpetra::CrsGraph.
 
 Tpetra_Details_getNumDiags.hpp
 Declaration and definition of getLocalNumDiags and getGlobalNumDiags.
 
 Tpetra_Details_Hash.cpp
 
 Tpetra_Details_Hash.hpp
 
 Tpetra_Details_iallreduce.cpp
 
 Tpetra_Details_iallreduce.hpp
 Declaration of Tpetra::Details::iallreduce.
 
 Tpetra_Details_initializeKokkos.cpp
 
 Tpetra_Details_initializeKokkos.hpp
 Declaration of Tpetra::Details::initializeKokkos.
 
 Tpetra_Details_isInterComm.cpp
 
 Tpetra_Details_isInterComm.hpp
 Declaration of Tpetra::Details::isInterComm.
 
 Tpetra_Details_lclDot.hpp
 Declaration and definition of Tpetra::Details::lclDot, an implementation detail of Tpetra::MultiVector.
 
 Tpetra_Details_leftScaleLocalCrsMatrix.hpp
 Declaration and definition of Tpetra::Details::leftScaleLocalCrsMatrix.
 
 Tpetra_Details_LocalMap.hpp
 Declaration and definition of the Tpetra::Map class, an implementation detail of Tpetra::Map.
 
 Tpetra_Details_LocalMap_fwd.hpp
 Forward declaration of Tpetra::Details::LocalMap.
 
 Tpetra_Details_makeColMap_decl.hpp
 Declaration of Tpetra::Details::makeColMap, a function for creating the column Map of a Tpetra::CrsGraph.
 
 Tpetra_Details_makeColMap_def.hpp
 Definition of Tpetra::Details::makeColMap, a function for creating the column Map of a Tpetra::CrsGraph.
 
 Tpetra_Details_makeOptimizedColMap.hpp
 Optimize your graph's or matrix's column Map for better communication performance.
 
 Tpetra_Details_makeValidVerboseStream.cpp
 
 Tpetra_Details_makeValidVerboseStream.hpp
 
 Tpetra_Details_Merge.hpp
 
 Tpetra_Details_mpiIsInitialized.cpp
 
 Tpetra_Details_mpiIsInitialized.hpp
 
 Tpetra_Details_MpiTypeTraits.cpp
 
 Tpetra_Details_MpiTypeTraits.hpp
 Add specializations of Teuchos::Details::MpiTypeTraits for Kokkos::complex<float> and Kokkos::complex<double>, and import Teuchos::Details::MpiTypeTraits into the Tpetra::Details namespace.
 
 Tpetra_Details_normImpl.hpp
 Declaration and definition of Tpetra::Details::normImpl, which is an implementation detail of Tpetra::MultiVector.
 
 Tpetra_Details_OrdinalTraits.hpp
 Import KokkosSparse::OrdinalTraits, a traits class for "invalid" (flag) values of integer types, into the Tpetra::Details namespace.
 
 Tpetra_Details_packCrsGraph_decl.hpp
 Functions 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.
 
 Tpetra_Details_packCrsGraph_def.hpp
 Functions 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.
 
 Tpetra_Details_packCrsMatrix_decl.hpp
 Functions 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.
 
 Tpetra_Details_packCrsMatrix_def.hpp
 Functions 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.
 
 Tpetra_Details_PackTraits.hpp
 Declaration and generic definition of traits class that tells Tpetra::CrsMatrix how to pack and unpack data.
 
 Tpetra_Details_printOnce.cpp
 
 Tpetra_Details_printOnce.hpp
 Declaration of Tpetra::Details::printOnce.
 
 Tpetra_Details_Profiling.cpp
 
 Tpetra_Details_Profiling.hpp
 Declaration of Tpetra::Details::Profiling, a scope guard for Kokkos Profiling.
 
 Tpetra_Details_radixSort.hpp
 
 Tpetra_Details_reallocDualViewIfNeeded.hpp
 Declaration and definition of Tpetra::Details::reallocDualViewIfNeeded, an implementation detail of Tpetra.
 
 Tpetra_Details_residual.hpp
 Functions that allow for fused residual calculation.
 
 Tpetra_Details_rightScaleLocalCrsMatrix.hpp
 Declaration and definition of Tpetra::Details::rightScaleLocalCrsMatrix.
 
 Tpetra_Details_ScalarViewTraits.hpp
 Declaration and generic definition of traits class that tells Tpetra::CrsMatrix how to pack and unpack data.
 
 Tpetra_Details_scaleBlockDiagonal.hpp
 Functions that rescales a multivector (in-place) by a inverse of a block-diagonal matrix (as implied by the given MultiVector) or its transpose.
 
 Tpetra_Details_shortSort.hpp
 Declaration and definition of functions for sorting "short" arrays of keys and corresponding values.
 
 Tpetra_Details_StaticView.cpp
 
 Tpetra_Details_StaticView.hpp
 
 Tpetra_Details_temporaryViewUtils.hpp
 
 Tpetra_Details_Transfer.cpp
 
 Tpetra_Details_Transfer_decl.hpp
 
 Tpetra_Details_Transfer_def.hpp
 
 Tpetra_Details_Transfer_fwd.hpp
 Forward declaration of Tpetra::Details::Transfer.
 
 Tpetra_Details_unpackCrsGraphAndCombine_decl.hpp
 Declaration 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.
 
 Tpetra_Details_unpackCrsGraphAndCombine_def.hpp
 Definition 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.
 
 Tpetra_Details_unpackCrsMatrixAndCombine_decl.hpp
 Declaration 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.
 
 Tpetra_Details_unpackCrsMatrixAndCombine_def.hpp
 Definition 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.
 
 Tpetra_Details_WrappedDualView.hpp
 
 Tpetra_Directory_decl.hpp
 
 Tpetra_Directory_def.hpp
 
 Tpetra_Directory_fwd.hpp
 Forward declaration of Tpetra::Directory.
 
 Tpetra_DirectoryImpl_decl.hpp
 Declaration of implementation details of Tpetra::Directory.
 
 Tpetra_DirectoryImpl_def.hpp
 Definition of implementation details of Tpetra::Directory.
 
 Tpetra_DistObject_decl.hpp
 Declaration of the Tpetra::DistObject class.
 
 Tpetra_DistObject_def.hpp
 Definition of the Tpetra::DistObject class.
 
 Tpetra_DistObject_fwd.hpp
 Forward declaration of Tpetra::DistObject.
 
 Tpetra_Distributor.cpp
 
 Tpetra_Distributor.hpp
 
 Tpetra_EpetraRowMatrix.cpp
 
 Tpetra_EpetraRowMatrix.hpp
 
 Tpetra_Exceptions.cpp
 
 Tpetra_Exceptions_decl.hpp
 Declarations of Tpetra-specific exceptions.
 
 Tpetra_Exceptions_def.hpp
 
 Tpetra_Export_decl.hpp
 
 Tpetra_Export_def.hpp
 
 Tpetra_Export_fwd.hpp
 Forward declaration of Tpetra::Export.
 
 Tpetra_FECrsGraph_decl.hpp
 Declaration of the Tpetra::FECrsGraph class.
 
 Tpetra_FECrsGraph_def.hpp
 
 Tpetra_FECrsGraph_fwd.hpp
 Forward declaration of Tpetra::FECrsGraph.
 
 Tpetra_FECrsMatrix_decl.hpp
 Declaration of the Tpetra::FECrsMatrix class.
 
 Tpetra_FECrsMatrix_def.hpp
 
 Tpetra_FECrsMatrix_fwd.hpp
 Forward declaration of Tpetra::FECrsMatrix.
 
 Tpetra_FEMultiVector_decl.hpp
 Declaration of the Tpetra::MultiVector class.
 
 Tpetra_FEMultiVector_def.hpp
 
 Tpetra_FEMultiVector_fwd.hpp
 Forward declaration of Tpetra::FEMultiVector.
 
 Tpetra_HashTable.cpp
 
 Tpetra_HashTable_decl.hpp
 
 Tpetra_HashTable_def.hpp
 
 Tpetra_iallreduce.hpp
 Declaration of Tpetra::iallreduce.
 
 Tpetra_idot.hpp
 Declaration of Tpetra::idot, a nonblocking dot product.
 
 Tpetra_Import_decl.hpp
 
 Tpetra_Import_def.hpp
 
 Tpetra_Import_fwd.hpp
 Forward declaration of Tpetra::Import.
 
 Tpetra_Import_Util.hpp
 Internal functions and macros designed for use with Tpetra::Import and Tpetra::Export objects.
 
 Tpetra_Import_Util2.hpp
 Utility functions for packing and unpacking sparse matrix entries.
 
 Tpetra_ImportExportData_decl.hpp
 
 Tpetra_ImportExportData_def.hpp
 
 Tpetra_ImportExportData_fwd.hpp
 Forward declaration of Tpetra::ImportExportData.
 
 Tpetra_leftAndOrRightScaleCrsMatrix_decl.hpp
 Declaration of Tpetra::leftAndOrRightScaleCrsMatrix.
 
 Tpetra_leftAndOrRightScaleCrsMatrix_def.hpp
 Definition of Tpetra::leftAndOrRightScaleCrsMatrix.
 
 Tpetra_LocalCrsMatrixOperator_decl.hpp
 
 Tpetra_LocalCrsMatrixOperator_def.hpp
 
 Tpetra_LocalCrsMatrixOperator_fwd.hpp
 
 Tpetra_LocalOperator.hpp
 
 Tpetra_LocalOperator_fwd.hpp
 Forward declaration of Tpetra::LocalCrsMatrixOperator.
 
 Tpetra_Map.cpp
 
 Tpetra_Map_decl.hpp
 Declaration of the Tpetra::Map class and related nonmember constructors.
 
 Tpetra_Map_def.hpp
 
 Tpetra_Map_fwd.hpp
 Forward declaration of Tpetra::Map.
 
 Tpetra_MixedScalarMultiplyOp.hpp
 
 Tpetra_MultiVector_decl.hpp
 Declaration of the Tpetra::MultiVector class.
 
 Tpetra_MultiVector_def.hpp
 Definition of the Tpetra::MultiVector class.
 
 Tpetra_MultiVector_fwd.hpp
 Forward declaration of Tpetra::MultiVector.
 
 Tpetra_Operator.hpp
 
 Tpetra_Operator_fwd.hpp
 Forward declaration of Tpetra::Operator.
 
 Tpetra_Packable.hpp
 Declaration of Tpetra::Packable.
 
 Tpetra_Packable_fwd.hpp
 Forward declaration of Tpetra::Packable.
 
 Tpetra_replaceDiagonalCrsMatrix_decl.hpp
 Declaration of Tpetra::replaceDiagonalCrsMatrix.
 
 Tpetra_replaceDiagonalCrsMatrix_def.hpp
 Definition of Tpetra::repalceDiagonalCrsMatrix.
 
 Tpetra_RowGraph.cpp
 
 Tpetra_RowGraph_decl.hpp
 
 Tpetra_RowGraph_def.hpp
 
 Tpetra_RowGraph_fwd.hpp
 Forward declaration of Tpetra::RowGraph.
 
 Tpetra_RowMatrix_decl.hpp
 
 Tpetra_RowMatrix_def.hpp
 
 Tpetra_RowMatrix_fwd.hpp
 Forward declaration of Tpetra::RowMatrix.
 
 Tpetra_RowMatrixTransposer_decl.hpp
 
 Tpetra_RowMatrixTransposer_def.hpp
 
 Tpetra_RowMatrixTransposer_fwd.hpp
 Forward declaration of Tpetra::RowMatrixTransposer.
 
 Tpetra_SrcDistObject.hpp
 Abstract base class for sources of an Import or Export.
 
 Tpetra_TieBreak.hpp
 Interface for breaking ties in ownership.
 
 Tpetra_TieBreak_fwd.hpp
 Forward declaration for Tpetra::TieBreak.
 
 Tpetra_TsqrAdaptor.hpp
 Adaptor from Tpetra::MultiVector to TSQR.
 
 Tpetra_Util.cpp
 
 Tpetra_Util.hpp
 Stand-alone utility functions and macros.
 
 Tpetra_Vector_decl.hpp
 Declaration of the Tpetra::Vector class.
 
 Tpetra_Vector_def.hpp
 Definition of the Tpetra::Vector class.
 
 Tpetra_Vector_fwd.hpp
 Forward declaration of Tpetra::Vector.
 
 Tpetra_Version.cpp
 
 Tpetra_Version.hpp