Amesos2 - Direct Sparse Solver Interfaces  Version of the Day
File List
Here is a list of all documented files with brief descriptions:
o*Amesos2.hpp
o*Amesos2_AbstractConcreteMatrixAdapter.hpp
o*Amesos2_AbstractConcreteMatrixAdapter_def.hpp
o*Amesos2_Basker.hpp
o*Amesos2_Basker_decl.hppAmesos2 Basker declarations
o*Amesos2_Basker_def.hppDefinitions for the Amesos2 Basker solver interface
o*Amesos2_Basker_FunctionMap.hpp
o*Amesos2_Basker_TypeMap.cppDefinitions for Basker TypeMap
o*Amesos2_Basker_TypeMap.hppProvides definition of Basker types
o*Amesos2_Cholmod.hpp
o*Amesos2_Cholmod_decl.hppAmesos2 CHOLMOD declarations
o*Amesos2_Cholmod_def.hppDefinitions for the Amesos2 Cholmod solver interface
o*Amesos2_Cholmod_FunctionMap.hppTemplate for providing a mechanism to map function calls to the correct Solver function based on the scalar type of Matrices and MultiVectors
o*Amesos2_Cholmod_TypeMap.hppProvides definition of Cholmod types as well as conversions and type traits
o*Amesos2_ConcreteMatrixAdapter.hpp
o*Amesos2_ConcreteMatrixAdapter_decl.hpp
o*Amesos2_ConcreteMatrixAdapter_def.hpp
o*Amesos2_Control.cppImplementation for Amesos2::Control
o*Amesos2_Control.hppContainer class for control variables
o*Amesos2_ctassert.hppSimple compile-time assertion class
o*Amesos2_cuSOLVER.hpp
o*Amesos2_cuSOLVER_decl.hpp
o*Amesos2_cuSOLVER_def.hpp
o*Amesos2_cuSOLVER_FunctionMap.hpp
o*Amesos2_cuSOLVER_TypeMap.hpp
o*Amesos2_Details_LinearSolverFactory.hpp
o*Amesos2_Details_LinearSolverFactory_decl.hppDeclaration of Amesos2::Details::LinearSolverFactory
o*Amesos2_Details_LinearSolverFactory_def.hppDefinition of Amesos2::Details::LinearSolverFactory
o*Amesos2_Details_registerLinearSolverFactory.hppDeclaration of Amesos2::Details::registerLinearSolverFactory
o*Amesos2_EpetraCrsMatrix_MatrixAdapter.hpp
o*Amesos2_EpetraCrsMatrix_MatrixAdapter_decl.hppSpecialization of the ConcreteMatrixAdapter for Epetra_CrsMatrix. Inherits all its functionality from the Epetra_RowMatrix specialization of AbstractConcreteMatrixAdapter
o*Amesos2_EpetraCrsMatrix_MatrixAdapter_def.hpp
o*Amesos2_EpetraMultiVecAdapter.hpp
o*Amesos2_EpetraMultiVecAdapter_decl.hppAmesos2::MultiVecAdapter specialization for the Epetra_MultiVector class
o*Amesos2_EpetraMultiVecAdapter_def.hppAmesos2::MultiVecAdapter specialization for the Epetra_MultiVector class
o*Amesos2_EpetraRowMatrix_AbstractMatrixAdapter.hpp
o*Amesos2_EpetraRowMatrix_AbstractMatrixAdapter_decl.hppProvides the Epetra_RowMatrix abstraction for the concrete Epetra row matric adapters
o*Amesos2_EpetraRowMatrix_AbstractMatrixAdapter_def.hppDefinitions for the Epetra_RowMatrix abstract adapter
o*Amesos2_ExplicitInstantiationHelpers.hpp
o*Amesos2_Factory.hppContains declarations for Amesos2::create and Amesos2::query
o*Amesos2_FunctionMap.hppDeclaration of Function mapping class for Amesos2
o*Amesos2_KLU2.hpp
o*Amesos2_KLU2_decl.hppAmesos2 KLU2 declarations
o*Amesos2_KLU2_def.hppDefinitions for the Amesos2 KLU2 solver interface
o*Amesos2_KLU2_FunctionMap.hppProvides a mechanism to map function calls to the correct Solver function based on the scalar type of Matrices and MultiVectors
o*Amesos2_KLU2_TypeMap.cppDefinitions for KLU2 TypeMap
o*Amesos2_KLU2_TypeMap.hppProvides definition of KLU2 types as well as conversions and type traits
o*Amesos2_Kokkos_Impl.hppETI for Solvers using Kokkos adapter
o*Amesos2_Kokkos_View_Copy_Assign.hppCopy or assign views based on memory spaces
o*Amesos2_KokkosCrsMatrix_MatrixAdapter.hpp
o*Amesos2_KokkosCrsMatrix_MatrixAdapter_decl.hppSpecialization of the ConcreteMatrixAdapter for KokkosSparse::CrsMatrix
o*Amesos2_KokkosCrsMatrix_MatrixAdapter_def.hpp
o*Amesos2_KokkosMultiVecAdapter.hpp
o*Amesos2_KokkosMultiVecAdapter_decl.hppAmesos2::MultiVecAdapter specialization for the Kokkos::View class
o*Amesos2_KokkosMultiVecAdapter_def.hppAmesos2::MultiVecAdapter specialization for the Kokkos::View class
o*Amesos2_Lapack.hpp
o*Amesos2_Lapack_decl.hppDeclarations for the Amesos2 interface to LAPACK
o*Amesos2_Lapack_def.hppDefinitions for the Amesos2 Lapack interface
o*Amesos2_MatrixAdapter.hpp
o*Amesos2_MatrixAdapter_decl.hpp
o*Amesos2_MatrixAdapter_def.hpp
o*Amesos2_MatrixHelper.hpp
o*Amesos2_MatrixTraits.hpp
o*Amesos2_Meta.hppProvides some simple meta-programming utilities for Amesos2
o*Amesos2_MultiVecAdapter.hppA templated adapter/wrapper class for Trilinos Multivector type classes. Provides the functions necessary for Amesos2 to function. Other wrapper methods may of course be added for special cases
o*Amesos2_MultiVecAdapter_decl.hpp
o*Amesos2_MultiVecAdapter_def.hpp
o*Amesos2_MUMPS.hpp
o*Amesos2_MUMPS_decl.hppAmesos2 MUMPS declarations
o*Amesos2_MUMPS_def.hppDefinitions for the Amesos2 MUMPS solver interface
o*Amesos2_MUMPS_FunctionMap.hppProvides a mechanism to map function calls to the correct Solver function based on the scalar type of Matrices and MultiVectors
o*Amesos2_MUMPS_TypeMap.cppDefinitions for MUMPS TypeMap
o*Amesos2_MUMPS_TypeMap.hppProvides definition of MUMPS types as well as conversions and type traits
o*Amesos2_PardisoMKL.hpp
o*Amesos2_PardisoMKL_decl.hppA template class that does nothing useful besides show developers what, in general, needs to be done to add a new solver interface to the Amesos2 collection
o*Amesos2_PardisoMKL_def.hppDefinitions for the Amesos2 PardisoMKL interface
o*Amesos2_PardisoMKL_FunctionMap.hpp
o*Amesos2_PardisoMKL_TypeMap.hppProvides definition of PardisoMKL types as well as conversions and type traits. For the purpose of demonstration, we assume that PardisoMKL has defined its own complex data-types called `complex' and `doublecomplex'
o*Amesos2_ShyLUBasker.hpp
o*Amesos2_ShyLUBasker_decl.hppAmesos2 ShyLUBasker declarations
o*Amesos2_ShyLUBasker_def.hppDefinitions for the Amesos2 ShyLUBasker solver interface
o*Amesos2_ShyLUBasker_FunctionMap.hpp
o*Amesos2_ShyLUBasker_TypeMap.cppDefinitions for ShyLUBasker_TypeMap
o*Amesos2_ShyLUBasker_TypeMap.hppProvides definition of ShyLUBasker types as well as conversions and type traits
o*Amesos2_Solver.hpp
o*Amesos2_Solver_decl.hppInterface to Amesos2 solver objects
o*Amesos2_SolverCore.hpp
o*Amesos2_SolverCore_decl.hppTemplated core-functionality class for Amesos2 solvers
o*Amesos2_SolverCore_def.hpp
o*Amesos2_SolverTraits.hppProvides access to interesting solver traits
o*Amesos2_Status.hppContainer class for status variables
o*Amesos2_STRUMPACK.hpp
o*Amesos2_STRUMPACK_decl.hpp
o*Amesos2_STRUMPACK_def.hpp
o*Amesos2_Superlu.hpp
o*Amesos2_Superlu_decl.hppAmesos2 Superlu declarations
o*Amesos2_Superlu_def.hppDefinitions for the Amesos2 Superlu solver interface
o*Amesos2_Superlu_FunctionMap.hppProvides a mechanism to map function calls to the correct Solver function based on the scalar type of Matrices and MultiVectors
o*Amesos2_Superlu_TypeMap.cppDefinitions for SuperLU TypeMap
o*Amesos2_Superlu_TypeMap.hppProvides definition of SuperLU types as well as conversions and type traits
o*Amesos2_Superludist.hpp
o*Amesos2_Superludist_decl.hppAmesos2 SuperLU_Dist declarations
o*Amesos2_Superludist_def.hppDefinitions for the Amesos2 SuperLU_DIST solver interface
o*Amesos2_Superludist_FunctionMap.hppProvides a mechanism to map function calls to the correct Solver function based on the scalar type of Matrices and MultiVectors
o*Amesos2_Superludist_TypeMap.cppDefinitions for SuperLU_DIST TypeMap
o*Amesos2_Superludist_TypeMap.hppProvides definition of SuperLU_DIST types as well as conversions and type traits
o*Amesos2_Superlumt.hpp
o*Amesos2_Superlumt_decl.hppAmesos2 SuperLU_MT declarations
o*Amesos2_Superlumt_def.hppDefinitions for the Amesos2 SuperLU_MT solver interface
o*Amesos2_Superlumt_FunctionMap.hppProvides a mechanism to map function calls to the correct Solver function based on the scalar type of Matrices and MultiVectors
o*Amesos2_Superlumt_TypeMap.cppDefinitions for SuperLU_MT TypeMap
o*Amesos2_Superlumt_TypeMap.hppProvides definition of SuperLU_MT types as well as conversions and type traits
o*Amesos2_Tacho.hpp
o*Amesos2_Tacho_decl.hpp
o*Amesos2_Tacho_def.hpp
o*Amesos2_Tacho_FunctionMap.hpp
o*Amesos2_Tacho_TypeMap.hpp
o*Amesos2_Timers.hppContainer class for Timers used with the Amesos2::Solver class
o*Amesos2_TpetraCrsMatrix_MatrixAdapter.hpp
o*Amesos2_TpetraCrsMatrix_MatrixAdapter_decl.hppSpecialization of the ConcreteMatrixAdapter for Tpetra::CrsMatrix. Inherits all its functionality from the Tpetra::RowMatrix specialization of AbstractConcreteMatrixAdapter
o*Amesos2_TpetraCrsMatrix_MatrixAdapter_def.hpp
o*Amesos2_TpetraMultiVecAdapter.hpp
o*Amesos2_TpetraMultiVecAdapter_decl.hppAmesos2::MultiVecAdapter specialization for the Tpetra::MultiVector class
o*Amesos2_TpetraMultiVecAdapter_def.hppAmesos2::MultiVecAdapter specialization for the Tpetra::MultiVector class
o*Amesos2_TpetraRowMatrix_AbstractMatrixAdapter.hpp
o*Amesos2_TpetraRowMatrix_AbstractMatrixAdapter_decl.hpp
o*Amesos2_TpetraRowMatrix_AbstractMatrixAdapter_def.hpp
o*Amesos2_TypeDecl.hppEnum and other types declarations for Amesos2
o*Amesos2_TypeMap.hpp
o*Amesos2_Umfpack.hpp
o*Amesos2_Umfpack_decl.hpp
o*Amesos2_Umfpack_def.hpp
o*Amesos2_Umfpack_FunctionMap.hpp
o*Amesos2_Umfpack_TypeMap.hpp
o*Amesos2_Util.hppUtility functions for Amesos2
o*Amesos2_VectorTraits.hpp
o*Amesos2_Version.hpp
o*basker.hpp
o*basker_decl.hpp
o*basker_def.hpp
o*basker_scalartraits.hpp
o*basker_types.hpp
o*klu2.hpp
o*klu2_analyze.hpp
o*klu2_analyze_given.hpp
o*klu2_defaults.hpp
o*klu2_diagnostics.hpp
o*klu2_dump.hpp
o*klu2_ext.hpp
o*klu2_extract.hpp
o*klu2_factor.hpp
o*klu2_free_numeric.hpp
o*klu2_free_symbolic.hpp
o*klu2_kernel.hpp
o*klu2_memory.hpp
o*klu2_refactor.hpp
o*klu2_scale.hpp
o*klu2_simple.cpp
o*klu2_solve.hpp
o*klu2_sort.hpp
\*klu2_tsolve.hpp