Ifpack2 Templated Preconditioning Package  Version 1.0
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
src Directory Reference
Directory dependency graph for src:
src

Files

file  Ifpack2_AdditiveSchwarz_decl.hpp [code]
 Declaration of Ifpack2::AdditiveSchwarz, which implements additive Schwarz preconditioning with an arbitrary subdomain solver.
 
file  Ifpack2_AdditiveSchwarz_def.hpp [code]
 Definition of Ifpack2::AdditiveSchwarz, which implements additive Schwarz preconditioning with an arbitrary subdomain solver. For the declaration and class documentation, please see Ifpack2_AdditiveSchwarz_decl.hpp in this directory.
 
file  Ifpack2_BandedContainer_decl.hpp [code]
 Ifpack2::BandedContainer class declaration.
 
file  Ifpack2_BandedContainer_def.hpp [code]
 
file  Ifpack2_BlockComputeResidualVector.hpp [code]
 
file  Ifpack2_BlockHelper.hpp [code]
 
file  Ifpack2_BlockRelaxation_decl.hpp [code]
 Ifpack2::BlockRelaxation class declaration.
 
file  Ifpack2_BlockRelaxation_def.hpp [code]
 
file  Ifpack2_BlockTriDiContainer_decl.hpp [code]
 Ifpack2::BlockTriDiContainer class declaration.
 
file  Ifpack2_BlockTriDiContainer_def.hpp [code]
 
file  Ifpack2_BlockTriDiContainer_impl.hpp [code]
 
file  Ifpack2_BorderedOperator_decl.hpp [code]
 
file  Ifpack2_BorderedOperator_def.hpp [code]
 
file  Ifpack2_Chebyshev_decl.hpp [code]
 Declaration of Chebyshev interface.
 
file  Ifpack2_Chebyshev_def.hpp [code]
 
file  Ifpack2_Condest.hpp [code]
 
file  Ifpack2_CondestType.hpp [code]
 
file  Ifpack2_ConfigDefs.hpp [code]
 
file  Ifpack2_Container_decl.hpp [code]
 
file  Ifpack2_Container_def.hpp [code]
 
file  Ifpack2_ContainerFactory_decl.hpp [code]
 Ifpack2::ContainerFactory class declaration.
 
file  Ifpack2_ContainerFactory_def.hpp [code]
 
file  Ifpack2_CreateOverlapGraph.hpp [code]
 
file  Ifpack2_DatabaseSchwarz_decl.hpp [code]
 Declaration of DatabaseSchwarz class.
 
file  Ifpack2_DatabaseSchwarz_def.hpp [code]
 
file  Ifpack2_DenseContainer_decl.hpp [code]
 Ifpack2::DenseContainer class declaration.
 
file  Ifpack2_DenseContainer_def.hpp [code]
 
file  Ifpack2_Details_AdditiveSchwarzFilter_decl.hpp [code]
 
file  Ifpack2_Details_AdditiveSchwarzFilter_def.hpp [code]
 
file  Ifpack2_Details_Amesos2Wrapper_decl.hpp [code]
 Declaration of wrapper for Amesos2 solvers.
 
file  Ifpack2_Details_Amesos2Wrapper_def.hpp [code]
 
file  Ifpack2_Details_CanChangeMatrix.hpp [code]
 Declaration of interface for preconditioners that can change their matrix after construction.
 
file  Ifpack2_Details_Chebyshev_decl.hpp [code]
 Declaration of Chebyshev implementation.
 
file  Ifpack2_Details_Chebyshev_def.hpp [code]
 Definition of Chebyshev implementation.
 
file  Ifpack2_Details_Chebyshev_Weights.hpp [code]
 Definition of Chebyshev implementation.
 
file  Ifpack2_Details_ChebyshevKernel_decl.hpp [code]
 Declaration of Ifpack2::Details::ChebyshevKernel.
 
file  Ifpack2_Details_ChebyshevKernel_def.hpp [code]
 
file  Ifpack2_Details_CrsArrays.hpp [code]
 Provides functions for retrieving local CRS arrays (row pointers, column indices, and values) from Tpetra::RowMatrix. This is used by Ifpack2's FastILU wrapper.
 
file  Ifpack2_Details_DenseSolver_decl.hpp [code]
 
file  Ifpack2_Details_DenseSolver_def.hpp [code]
 
file  Ifpack2_Details_Factory_decl.hpp [code]
 
file  Ifpack2_Details_Factory_def.hpp [code]
 
file  Ifpack2_Details_FastILU_Base_decl.hpp [code]
 Defines Ifpack2::Details::FastILU_Base, the base class that contains all common data and behavior of Ifpack2's FastILU, FastILDL and FastIC preconditioners.
 
file  Ifpack2_Details_FastILU_Base_def.hpp [code]
 
file  Ifpack2_Details_Fic_decl.hpp [code]
 
file  Ifpack2_Details_Fic_def.hpp [code]
 
file  Ifpack2_Details_Fildl_decl.hpp [code]
 
file  Ifpack2_Details_Fildl_def.hpp [code]
 
file  Ifpack2_Details_Filu_decl.hpp [code]
 
file  Ifpack2_Details_Filu_def.hpp [code]
 
file  Ifpack2_Details_GaussSeidel.hpp [code]
 
file  Ifpack2_Details_getCrsMatrix.hpp [code]
 
file  Ifpack2_Details_getParamTryingTypes.hpp [code]
 
file  Ifpack2_Details_InverseDiagonalKernel_decl.hpp [code]
 
file  Ifpack2_Details_InverseDiagonalKernel_def.hpp [code]
 
file  Ifpack2_Details_LapackSupportsScalar.hpp [code]
 
file  Ifpack2_Details_LinearSolver_decl.hpp [code]
 
file  Ifpack2_Details_LinearSolver_def.hpp [code]
 Definition of Ifpack2::Details::LinearSolver.
 
file  Ifpack2_Details_LinearSolverFactory_decl.hpp [code]
 Declaration of Ifpack2::Details::LinearSolverFactory.
 
file  Ifpack2_Details_LinearSolverFactory_def.hpp [code]
 Definition of Ifpack2::Details::LinearSolverFactory.
 
file  Ifpack2_Details_MultiVectorLocalGatherScatter.hpp [code]
 Declaration and definition of the Ifpack2::Details::MultiVectorLocalGatherScatter class.
 
file  Ifpack2_Details_NestedPreconditioner.hpp [code]
 Declaration of interface for nested preconditioners.
 
file  Ifpack2_Details_OneLevelFactory_decl.hpp [code]
 
file  Ifpack2_Details_OneLevelFactory_def.hpp [code]
 
file  Ifpack2_Details_OverlappingRowGraph_decl.hpp [code]
 
file  Ifpack2_Details_OverlappingRowGraph_def.hpp [code]
 
file  Ifpack2_Details_registerLinearSolverFactory.cpp
 
file  Ifpack2_Details_registerLinearSolverFactory.hpp [code]
 Declaration of Ifpack2::Details::registerLinearSolverFactory.
 
file  Ifpack2_Details_RowGraph.hpp [code]
 
file  Ifpack2_Details_RowMatrix.hpp [code]
 
file  Ifpack2_Details_ScaledDampedResidual_decl.hpp [code]
 Declaration of Ifpack2::Details::ScaledDampedResidual.
 
file  Ifpack2_Details_ScaledDampedResidual_def.hpp [code]
 
file  Ifpack2_Details_throwBecauseDeprecated.cpp
 
file  Ifpack2_Details_throwBecauseDeprecated.hpp [code]
 
file  Ifpack2_Details_TriDiSolver_decl.hpp [code]
 
file  Ifpack2_Details_TriDiSolver_def.hpp [code]
 
file  Ifpack2_Details_UserPartitioner_decl.hpp [code]
 Declaration of a user-defined partitioner in which the user can define a partition of the graph. The partition may have locally overlapping parts.
 
file  Ifpack2_Details_UserPartitioner_def.hpp [code]
 
file  Ifpack2_Diagonal_decl.hpp [code]
 
file  Ifpack2_Diagonal_def.hpp [code]
 
file  Ifpack2_DiagonalFilter_decl.hpp [code]
 
file  Ifpack2_DiagonalFilter_def.hpp [code]
 
file  Ifpack2_DropFilter_decl.hpp [code]
 
file  Ifpack2_DropFilter_def.hpp [code]
 
file  Ifpack2_Experimental_RBILUK_decl.hpp [code]
 Declaration of RBILUK interface.
 
file  Ifpack2_Experimental_RBILUK_def.hpp [code]
 
file  Ifpack2_ExplicitInstantiationHelpers.hpp [code]
 
file  Ifpack2_Factory.cpp
 
file  Ifpack2_Factory_decl.hpp [code]
 
file  Ifpack2_Factory_def.hpp [code]
 
file  Ifpack2_Heap.hpp [code]
 
file  Ifpack2_Hiptmair_decl.hpp [code]
 Declaration of Ifpack2::Hiptmair class.
 
file  Ifpack2_Hiptmair_def.hpp [code]
 
file  Ifpack2_Hypre.cpp
 
file  Ifpack2_Hypre_decl.hpp [code]
 
file  Ifpack2_Hypre_def.hpp [code]
 
file  Ifpack2_Hypre_FunctionParameters.hpp [code]
 
file  Ifpack2_IdentitySolver_decl.hpp [code]
 
file  Ifpack2_IdentitySolver_def.hpp [code]
 
file  Ifpack2_IlukGraph.hpp [code]
 Declaration and definition of IlukGraph.
 
file  Ifpack2_ILUT_decl.hpp [code]
 Declaration of ILUT preconditioner.
 
file  Ifpack2_ILUT_def.hpp [code]
 
file  Ifpack2_LinearPartitioner_decl.hpp [code]
 
file  Ifpack2_LinearPartitioner_def.hpp [code]
 
file  Ifpack2_LinePartitioner_decl.hpp [code]
 
file  Ifpack2_LinePartitioner_def.hpp [code]
 
file  Ifpack2_LocalFilter_decl.hpp [code]
 
file  Ifpack2_LocalFilter_def.hpp [code]
 
file  Ifpack2_LocalSparseTriangularSolver_decl.hpp [code]
 
file  Ifpack2_LocalSparseTriangularSolver_def.hpp [code]
 
file  Ifpack2_MDF_decl.hpp [code]
 
file  Ifpack2_MDF_def.hpp [code]
 
file  Ifpack2_OverlapGraph.hpp [code]
 
file  Ifpack2_OverlappingPartitioner_decl.hpp [code]
 
file  Ifpack2_OverlappingPartitioner_def.hpp [code]
 
file  Ifpack2_OverlappingRowMatrix_decl.hpp [code]
 
file  Ifpack2_OverlappingRowMatrix_def.hpp [code]
 
file  Ifpack2_Parameters.cpp
 
file  Ifpack2_Parameters.hpp [code]
 
file  Ifpack2_Partitioner.hpp [code]
 
file  Ifpack2_PowerMethod.hpp [code]
 Definition of power methods.
 
file  Ifpack2_Preconditioner.hpp [code]
 
file  Ifpack2_Relaxation_decl.hpp [code]
 
file  Ifpack2_Relaxation_def.hpp [code]
 
file  Ifpack2_ReorderFilter_decl.hpp [code]
 
file  Ifpack2_ReorderFilter_def.hpp [code]
 
file  Ifpack2_RILUK_decl.hpp [code]
 Declaration of MDF interface.
 
file  Ifpack2_RILUK_def.hpp [code]
 
file  Ifpack2_ScalingType.hpp [code]
 Ifpack2::ScalingType enumerable type.
 
file  Ifpack2_SingletonFilter_decl.hpp [code]
 
file  Ifpack2_SingletonFilter_def.hpp [code]
 
file  Ifpack2_SparseContainer_decl.hpp [code]
 Ifpack2::SparseContainer class declaration.
 
file  Ifpack2_SparseContainer_def.hpp [code]
 
file  Ifpack2_SparsityFilter_decl.hpp [code]
 
file  Ifpack2_SparsityFilter_def.hpp [code]
 
file  Ifpack2_TriDiContainer_decl.hpp [code]
 Ifpack2::TriDiContainer class declaration.
 
file  Ifpack2_TriDiContainer_def.hpp [code]
 
file  Ifpack2_Utilities.cpp
 
file  Ifpack2_Utilities.hpp [code]
 File for utility functions.
 
file  Ifpack2_Version.hpp [code]
 
file  Ifpack2_Zoltan2Partitioner_decl.hpp [code]
 
file  Ifpack2_Zoltan2Partitioner_def.hpp [code]