▶NAmesos2 | |
CSolver | |
▶NBelos | |
CMueLuOp | MueLuOp derives from Belos::OperatorT and administrates a MueLu::Hierarchy. It implements the apply call which represents the effect of the multigrid preconditioner on a given vector. Note, in contrast to Belos::XpetraOp this operator has the multigrid hierarchy |
CMueLuOpFailure | MueLuOpFailure is thrown when a return value from an MueLu call on an Xpetra::Operator or MueLu::Hierarchy is non-zero |
CStatusTestGenResSubNorm< Scalar, Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >, Belos::OperatorT< Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > > | Template specialization of Belos::StatusTestGenResSubNorm class using the Xpetra::MultiVector and Belos::OperatorT MueLu adapter class |
▶NMueLu | Namespace for MueLu classes and methods |
▶NDetails | |
CDropTol | |
CLinearSolver | |
CLinearSolver< Tpetra::MultiVector< Scalar, LO, GO, Node >, Tpetra::Operator< Scalar, LO, GO, Node >, typename Teuchos::ScalarTraits< Scalar >::magnitudeType > | |
CLinearSolverFactory | Interface for a "factory" that creates MueLu solvers |
▶NExceptions | |
CBadCast | Exception indicating invalid cast attempted |
CDependencyError | Exception throws to report data dependency problems between factories |
CIncompatible | Exception throws to report incompatible objects (like maps) |
CInvalidArgument | Exception throws to report invalid user entry |
CNotImplemented | Exception throws when you call an unimplemented method of MueLu |
COverflow | Exception throws to report overflows |
CRuntimeError | Exception throws to report errors in the internal logical of the program |
CAdaptiveSaMLParameterListInterpreter | |
CAdvSmootherPrototype | |
CAggregateQualityEstimateFactory | An factory which assigns each aggregate a quality estimate. Originally developed by Napov and Notay in the context of plain aggregation, while this quality estimate does not correspond to a robust convergence guarentee (as it does for plain aggregation), we find empirically that it is a good way of discovering poorly constructed aggregates even in the smoothed aggregation context |
CAggregates | Container class for aggregation information |
CAggregationAlgorithmBase | Pure virtual base class for all MueLu aggregation algorithms |
CAggregationExportFactory | Factory to export aggregation info or visualize aggregates using VTK |
CAggregationPhase1Algorithm | Algorithm for coarsening a graph with uncoupled aggregation |
CAggregationPhase2aAlgorithm | Among unaggregated points, see if we can make a reasonable size aggregate out of it.Idea
Among unaggregated points, see if we can make a reasonable size aggregate out of it. We do this by looking at neighbors and seeing how many are unaggregated and on my processor. Loosely, base the number of new aggregates created on the percentage of unaggregated nodes |
CAggregationPhase2bAlgorithm | Add leftovers to existing aggregatesIdea
In phase 2b non-aggregated nodes are added to existing aggregates. All neighbors of the unaggregated node are checked and the corresponding aggregate weight is increased. The unaggregated node is added to the aggregate with the best weight. A simple penalty strategy makes sure that the non-aggregated nodes are added to different aggregates. The routine runs twice to cover non-aggregate nodes which have a node distance of two to existing aggregates. Assuming that the node distance is not greater than 3 (the aggregate diameter size), running the algorithm only twice should be sufficient |
CAggregationPhase3Algorithm | Handle leftover nodes. Try to avoid singleton nodesIdea
In phase 3 we try to stick unaggregated nodes into a neighboring aggregate. We try to avoid singletons: we first try to build a new aggregate containing all neighboring non-aggregated nodes. If we cannot build a new aggregate, we add the non-aggregated node to the first adjacent aggregate. Only if there is no adjacent aggregate, we create a singleton node aggregate |
CAggregationStructuredAlgorithm | Algorithm for coarsening a graph with structured aggregation |
▶CAggregationStructuredAlgorithm_kokkos | |
CcomputeGraphDataConstantFunctor | |
CcomputeGraphDataLinearFunctor | |
CcomputeGraphRowPtrFunctor | |
CfillAggregatesFunctor | |
CAlgebraicPermutationStrategy | Algebraic permutation strategy |
CAmalgamationFactory | AmalgamationFactory for subblocks of strided map based amalgamation data |
CAmalgamationInfo | Minimal container class for storing amalgamation information |
CAmesos2Smoother | Class that encapsulates Amesos2 direct solvers |
CAmesos2Smoother< double, int, int, Xpetra::EpetraNode > | |
CAmesosSmoother | Class that encapsulates Amesos direct solvers |
CAMGXOperator | Adapter for AmgX library from Nvidia |
CAMGXOperator< double, int, int, Node > | |
CBaseClass | Base class for MueLu classes |
CBelosSmoother | Class that encapsulates Belos smoothers |
CBelosSmoother< double, int, int, Xpetra::EpetraNode > | |
▶CBlackBoxPFactory | Prolongator factory performing geometric coarsening |
CNodeID | |
CNodesIDs | |
CBlockedCoarseMapFactory | Factory for generating coarse level map. Used by BlockedPFactory |
CBlockedCoordinatesTransferFactory | Class for transferring coordinates from a finer level to a coarser one for BlockedCrsMatrices. This basically combines the Coordinates generated by each separate block |
CBlockedDirectSolver | Direct solver for nxn blocked matrices |
CBlockedGaussSeidelSmoother | Block Gauss-Seidel method for blocked matrices |
CBlockedJacobiSmoother | Block Jacobi method for blocked matrices |
CBlockedPFactory | Factory for building blocked, segregated prolongation operators |
CBlockedRAPFactory | Factory for building coarse matrices |
CBraessSarazinSmoother | BraessSarazin smoother for 2x2 block matrices |
▶CBrickAggregationFactory | |
Ccompare | |
CCGSolver | Implements conjugate gradient algorithm for energy-minimization |
CCloneRepartitionInterface | Helper class which transforms an "Partition" array generated from a block in a blocked operator to a new "Partition" vector for another compatible block in the blocked operator |
CCoalesceDropFactory | Factory for creating a graph base on a given matrix |
CCoarseMapFactory | Factory for generating coarse level map. Used by TentativePFactory |
CCoarseningVisualizationFactory | Factory to visualize coarsening information using prolongation operators |
CCompPairs | |
CConstraint | Constraint space information for the potential prolongator |
CConstraintFactory | Factory for building the constraint operator |
CCoordinatesTransferFactory | Class for transferring coordinates from a finer level to a coarser one |
CCoupledAggregationCommHelper | Helper class for providing arbitrated communication across processors |
CCoupledAggregationFactory | Factory for coarsening a graph with uncoupled aggregation |
CCoupledRBMFactory | Nullspace Factory for coupled acoustic-elastic problems |
CDefaultProblemStrings | Helper class to initialize DefaultProblemTypeLists_ in class MasterList |
CDemoFactory | Empty factory for demonstration |
CDescribable | Base class for MueLu classes |
CDirectSolver | Class that encapsulates direct solvers. Autoselection of AmesosSmoother or Amesos2Smoother according to the compile time configuration of Trilinos |
CDisableMultipleCallCheck | An exception safe way to call the method TwoLevelFactoryBase::DisableMultipleCallCheck |
CDropNegativeEntriesFactory | Application-specific filtering for A. Can be used in context of graph coarsening and aggregation |
CEminPFactory | Factory for building Energy Minimization prolongators |
CFacadeBGS2x2 | |
CFacadeClassBase | |
CFacadeClassFactory | |
CFacadeSimple | |
CFactory | |
CFactoryAcceptor | |
CFactoryBase | Base class for factories (e.g., R, P, and A_coarse) |
CFactoryFactory | Factory that can generate other factories from |
CFactoryManager | This class specifies the default factory that should generate some data on a Level if the data does not exist and the generating factory has not been specified |
CFactoryManagerBase | Class that provides default factories within Needs class |
CFactoryMonitor | Timer to be used in factories. Similar to Monitor but with additional timers |
CFakeSmootherPrototype | |
CFilteredAFactory | Factory for building filtered matrices using filtered graphs |
CFineLevelInputDataFactory | |
CFormattingHelper | |
▶CGeneralGeometricPFactory | Prolongator factory performing geometric coarsening |
CGeometricData | |
CNodeID | |
CNodesIDs | |
CGenericRFactory | Factory for building restriction operators using a prolongator factory |
CGeoInterpFactory | Factory for GMG Q2-Q1-Q2 interpolation |
CGeometricInterpolationPFactory | |
▶CGeometricInterpolationPFactory_kokkos | |
CcoarseCoordinatesBuilderFunctor | |
CGlobalLexicographicIndexManager | |
CGMRESSolver | Implements conjugate gradient algorithm for energy-minimization |
CGraph | MueLu representation of a compressed row storage graph |
CGraphBase | MueLu representation of a graph |
▶CHierarchy | Provides methods to build a multigrid hierarchy and apply multigrid cycles |
CConvData | Data struct for defining stopping criteria of multigrid iteration |
CHierarchyFactory | |
CHierarchyManager | |
CHierarchyUtils | |
CHybridAggregationFactory | Factory for building aggregates on meshes partly structured and partly unstructured |
CIfpack2Smoother | Class that encapsulates Ifpack2 smoothers |
CIfpack2Smoother< double, int, int, Xpetra::EpetraNode > | |
CIfpackSmoother | Class that encapsulates Ifpack smoothers |
CIndefBlockedDiagonalSmoother | Cheap Blocked diagonal smoother for indefinite 2x2 block matrices |
CIndexManager | Container class for mesh layout and indices calculation |
CInterfaceAggregationAlgorithm | Algorithm for coarsening a graph with uncoupled aggregation. creates aggregates along an interface using specified root nodes |
CInterfaceAggregationFactory | Factory for building aggregates for Lagrange multipliers |
CInterfaceMappingTransferFactory | |
CIntrepidPCoarsenFactory | Factory for building transfer operators based on coarsening in polynomial degree, following the Intrepid basis functions |
CIsolatedNodeAggregationAlgorithm | Ignores isolated nodes during aggregation. Marks the node to be "aggregated" without adding real aggregates for them |
CIsorropiaInterface | Interface to IsorropiaInterface to Isorropia allowing to access other rebalancing/repartitioning algorithms from Zoltan than RCB This includes methods (like PHG) which do not rely on user-provided coordinate or mesh information. This class produces node-based rebalancing information (stored in "AmalgamatedPartition") which is used as input for the RepartitionInterface class |
CLeftoverAggregationAlgorithm | |
CLevel | Class that holds all level-specific information |
CLineDetectionFactory | Factory for building line detection information |
CLinkedList | |
CLocalAggregationAlgorithm | Algorithm for coarsening a graph with uncoupled aggregation |
CLocalLexicographicIndexManager | |
CLocalPermutationStrategy | Local permutation strategy |
CLWGraph | Lightweight MueLu representation of a compressed row storage graph |
CMapTransferFactory | Transfer factory for maps |
CMasterList | Static class that holds the complete list of valid MueLu parameters |
CMatlabSmoother | Class that encapsulates Matlab smoothers |
CMatrixAnalysisFactory | This class checks matrix properties of A on current level. This factory can be plugged in everywhere in the factory layout of the MueLu preconditioner. It only needs A as input and pipes it through as output |
CMergedBlockedMatrixFactory | |
CMergedSmoother | |
CMHDRAPFactory | Factory for building coarse matrices |
CML2MueLuParameterTranslator | Class that accepts ML-style parameters and builds a MueLu parameter list (easy input deck) |
CMLParameterListInterpreter | Class that accepts ML-style parameters and builds a MueLu preconditioner. This interpreter uses the same default values as ML. This allows to compare ML/MueLu results |
CMonitor | Timer to be used in non-factories |
CMueLu_Node_Struct | |
CMueLu_SuperNode_Struct | |
CMuemexArg | |
CMuemexData | |
CMultiVectorTransferFactory | Class for restricting a MultiVector from a finer to a coarser level |
CMutuallyExclusiveTime | This class wraps a Teuchos::Time and maintains a mutually exclusive property between wrapped timers |
CMutuallyExclusiveTimeMonitor | Similar to TimeMonitor, but uses MutuallyExclusiveTime objects |
CmyTriangle | |
CmyVec2 | |
CmyVec3 | |
CNodePartitionInterface | Partitioning within a node onlyThis interface provides partitioning within a node |
CNoFactory | NoFactory that is used for data stored in level class for that no generating factory is available/necessary |
CNotayAggregationFactory | |
CNullspaceFactory | Factory for generating nullspace |
CNullspacePresmoothFactory | |
COnePtAggregationAlgorithm | Algorithm for coarsening a graph with uncoupled aggregation. keep special marked nodes as singleton node aggregates over all multigrid levels |
CParameterListAcceptor | Abstract interface of a class accepting parameter lists |
CParameterListAcceptorImpl | |
CParameterListInterpreter | |
CPatternFactory | Factory for building nonzero patterns for energy minimization |
CPerfUtils | |
CPermutationFactory | Factory generates a row- and column permutation operators P and Q such that P*A*Q^T is a (hopefully) diagonal-dominant matrix. It's meant to be used with PermutingSmoother |
CPermutingSmoother | This class first calculates row- and column permutation operators and applies a smoother to the permuted linear system |
CPFactory | Factory that provides an interface for a concrete implementation of a prolongation operator |
CPgPFactory | Factory for building Petrov-Galerkin Smoothed Aggregation prolongators |
CPreDropFunctionBaseClass | |
CPreDropFunctionConstVal | |
CPreserveDirichletAggregationAlgorithm | Builds one-to-one aggregates for all Dirichlet boundary nodes. For some applications this might be necessary. (default = off) |
CPRFactory | |
CPrintMonitor | |
CProjectorSmoother | This class enables the elimination of the nullspace component of the solution through the use of projection |
CQ2Q1Q2CoarseGridFactory | Factory for GMG Q2-Q1-Q2 interpolation |
CRAPFactory | Factory for building coarse matrices |
CRAPShiftFactory | Factory for building coarse grid matrices, when the matrix is of the form K+a*M. Useful when you want to change the shift variable ("a") at every level. Each level must store the stiffness matrix K and mass matrix M separately |
CRebalanceAcFactory | Factory for building coarse matrices |
CRebalanceBlockAcFactory | |
CRebalanceBlockInterpolationFactory | Applies permutation to prolongation operators |
CRebalanceBlockRestrictionFactory | Applies permutation to restriction operators |
CRebalanceMapFactory | Factory which rebalances a map on current level using the Importer object generated by the RepartitionFactory |
CRebalanceTransferFactory | Applies permutation to grid transfer operators |
CRefMaxwell | Preconditioner (wrapped as a Xpetra::Operator) for Maxwell's equations in curl-curl form |
CReorderBlockAFactory | Factory for building a reordered (nested) block operator |
CRepartitionBlockDiagonalFactory | Factory which rebalances a map on current level using the Importer object generated by the RepartitionFactory |
CRepartitionFactory | Factory for building permutation matrix that can be be used to shuffle data (matrices, vectors) among processes |
CRepartitionHeuristicFactory | Factory for determing the number of partitions for rebalancing |
CRepartitionInterface | Helper class which transforms an "AmalgamatedPartition" array to an unamalgamated "Partition".This is a general class that allows to translate node-based rebalancing information (given by "AmalgamatedPartition") to DOF-based rebalancing information (stored as output in the "Partition" variable). It is meant to be used together with the IsorropiaInterface class which provides the node-based rebalancing information in the "AmalgamatedPartition" variable. It uses the striding information of "A" to transform the amalgamated rebalaning info into DOF-based rebalancing information that can be processed by the RepartitionFactory class |
CRigidBodyModeFactory | Nullspace Factory for building rigid body modes |
CSaPFactory | Factory for building Smoothed Aggregation prolongators |
CScaledNullspaceFactory | Factory for generating a very special nullspace |
CSchurComplementFactory | Factory for building the Schur Complement for a 2x2 block matrix |
CSegregatedAFactory | Factory for building a new "segregated" A operator. Here, "segregated" means that the user provides a map (containing a subset of the row gids of the input matrix A) and the factory drops the off-diagonal entries (a,b) and (b,a) in A where "a" denotes a GID entry in the provided map and "b" denotes a GID that is not contained in the provided map |
CSemiCoarsenPFactory | Prolongator factory performing semi-coarsening |
CSetFactoryManager | An exception safe way to call the method 'Level::SetFactoryManager()' |
CShiftedLaplacian | Shifted Laplacian Helmholtz solver |
CShiftedLaplacianOperator | Wraps an existing MueLu::Hierarchy as a Tpetra::Operator, with an optional two-level correction. Intended to be used with MueLu::ShiftedLaplacian |
CSimpleSmoother | SIMPLE smoother for 2x2 block matrices |
CSingleLevelFactoryBase | Base class for factories that use one level (currentLevel) |
CSingleLevelMatlabFactory | Factory for interacting with Matlab |
CSmoother | Base class for smoother factories |
CSmootherBase | Base class for smoothers |
CSmootherFactory | Generic Smoother Factory for generating the smoothers of the MG hierarchy |
CSmootherFactoryBase | |
CSmootherPrototype | Base class for smoother prototypes |
CSmooVecCoalesceDropFactory | Factory for creating a graph base on a given matrix |
CSolverBase | Base class for energy-minimization iterative solvers |
CSteepestDescentSolver | Implements steepest descent algorithm for energy-minimization |
CStructuredAggregationFactory | Factory for building aggregates on structured grids |
CStructuredLineDetectionFactory | Factory building line detection information on structured meshes |
CSubBlockAFactory | Factory for building a thresholded operator |
CSubFactoryMonitor | Timer to be used in factories. Similar to SubMonitor but adds a timer level by level |
CSubMonitor | Timer to be used in non-factories. Similar to Monitor, but doesn't print object description |
CTekoSmoother | Interface to block smoothers in Teko package |
CTekoSmoother< double, int, GlobalOrdinal, Node > | |
CTentativePFactory | Factory for building tentative prolongator |
CThresholdAFilterFactory | Factory for building a thresholded operator |
CTimeMonitor | Integrates Teuchos::TimeMonitor with MueLu verbosity system |
CToggleCoordinatesTransferFactory | Class for transferring coordinates from a finer level to a coarser one |
CTogglePFactory | Prolongator factory which allows switching between two different prolongator strategies |
CTopRAPFactory | |
CTopSmootherFactory | |
CTpetraOperator | Wraps an existing MueLu::Hierarchy as a Tpetra::Operator |
CTransPFactory | Factory for building restriction operators |
CTrilinosSmoother | Class that encapsulates external library smoothers |
CTriplet | |
CTwoLevelFactoryBase | Base class for factories that use two levels (fineLevel and coarseLevel) |
CTwoLevelMatlabFactory | Factory for interacting with Matlab |
CUncoupledAggregationFactory | Factory for building uncoupled aggregates |
CUncoupledIndexManager | |
CUnsmooshFactory | Factory for building "unsmooshed" transfer operators from transfer operators associated with a scalar helper problem (built by the VariableDofLaplacianFactory) |
CUserAggregationFactory | |
CUserPFactory | |
CUtilities | MueLu utility class |
CUtilities< double, int, int, Xpetra::EpetraNode > | |
CUtilitiesBase | |
CUzawaSmoother | Block triangle Uzawa smoother for 2x2 block matrices |
▶CVariableContainer | Class that stores all relevant data for a variable |
CData | |
CDataBase | |
CGetter | |
CGetter< Teuchos::RCP< Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > > | |
CVariableDofLaplacianFactory | Factory for building scalar Laplace operator (that is used as fake operator for variable dof size problems) |
CVerboseObject | Verbose class for MueLu classes |
CVisualizationHelpers | Base class providing routines to visualize aggregates and coarsening information |
CXpetraOperator | Wraps an existing MueLu::Hierarchy as a Xpetra::Operator |
CZoltan2Interface | Interface to Zoltan2 library.This interface provides access to partitioning methods in Zoltan2. Currently, it supports RCB and multijagged as well as all graph partitioning algorithms from Zoltan2 |
CZoltan2Interface< double, int, int, Xpetra::EpetraNode > | |
CZoltanInterface | Interface to Zoltan library.This interface provides access to partitioning methods in Zoltan. Currently, it supports the RCB algorithm only |
▶NMueLuTests | |
CBlackBoxPFactoryTester | |
CFineLevelInputDataFactoryTester | |
CGeneralGeometricPFactoryTester | |
▶NTeuchos | |
CComm | |
▶NThyra | |
CMueLuTpetraQ2Q1PreconditionerFactory | Concrete preconditioner factory subclass based on MueLu |
CXpetraLinearOp | Concrete Thyra::LinearOpBase subclass for Xpetra::Operator |
CAdaptiveSAMLParameterListInterpreter | Class that accepts ML-style parameters and builds a MueLu preconditioner. This interpreter uses the same default values as ML. This allows to compare ML/MueLu results |
CAlgebraicPermutationStrategy | Class which defines local permutations of matrix columns |
CBrickAggregationFactory | Aggregation method for generating "brick" aggregates |
CConstraint | Class which contains the constraint space details |
CFineLevelInputData | Factory for piping in input data from the finest level into the MueLu data dependency system |
CLocalPermutationStrategy | Class which defines local permutations of matrix columns which correspond to DOFs of the same node |
CMergedBlockedMatrix | Factory provides a merged version of a blocked matrix |
CMergedSmoother | |