MueLu
Version of the Day
|
Namespace for MueLu classes and methods. More...
Namespaces | |
Details | |
CoalesceDrop_Kokkos_Details | |
NotayUtils | |
AdaptiveDetails | |
MueLuIntrepid | |
Exceptions | |
MemUtils | |
PerfDetails | |
Classes | |
class | BrickAggregationFactory |
class | Aggregates |
Container class for aggregation information. More... | |
struct | MueLu_Node_Struct |
class | LinkedList |
class | LWGraph |
Lightweight MueLu representation of a compressed row storage graph. More... | |
class | LWGraph_kokkos |
Lightweight MueLu representation of a compressed row storage graph. More... | |
class | LWGraphBase |
class | MueLuGraphBaseAdapter |
class | HybridAggregationFactory |
Factory for building aggregates on meshes partly structured and partly unstructured. More... | |
class | AmalgamationFactory |
AmalgamationFactory for subblocks of strided map based amalgamation data. More... | |
class | AmalgamationInfo |
minimal container class for storing amalgamation information More... | |
class | CoalesceDropFactory |
Factory for creating a graph based on a given matrix. More... | |
class | CoalesceDropFactory_kokkos |
Factory for creating a graph based on a given matrix. More... | |
class | PreDropFunctionBaseClass |
class | PreDropFunctionConstVal |
class | SmooVecCoalesceDropFactory |
Factory for creating a graph base on a given matrix. More... | |
class | UnsmooshFactory |
Factory for building "unsmooshed" transfer operators from transfer operators associated with a scalar helper problem (built by the VariableDofLaplacianFactory) More... | |
class | VariableDofLaplacianFactory |
Factory for building scalar Laplace operator (that is used as fake operator for variable dof size problems) More... | |
class | AggregationAlgorithmBase |
Pure virtual base class for all MueLu aggregation algorithms. More... | |
class | NotayAggregationFactory |
class | GlobalLexicographicIndexManager |
class | LocalLexicographicIndexManager |
class | AggregationStructuredAlgorithm |
Algorithm for coarsening a graph with structured aggregation. More... | |
class | IndexManager |
Container class for mesh layout and indices calculation. More... | |
class | IndexManager_kokkos |
Container class for mesh layout and indices calculation. More... | |
class | StructuredAggregationFactory |
Factory for building aggregates on structured grids. More... | |
class | StructuredAggregationFactory_kokkos |
Factory for building structured aggregates or CrsGraph for interpolation base prolongator. More... | |
class | UncoupledIndexManager |
class | AggregationPhase1Algorithm |
Algorithm for coarsening a graph with uncoupled aggregation. More... | |
class | AggregationPhase2aAlgorithm |
Among unaggregated points, see if we can make a reasonable size aggregate out of it.IdeaAmong 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. More... | |
class | AggregationPhase2bAlgorithm |
Add leftovers to existing aggregatesIdeaIn 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. More... | |
class | AggregationPhase3Algorithm |
Handle leftover nodes. Try to avoid singleton nodesIdeaIn 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. More... | |
class | InterfaceAggregationAlgorithm |
Algorithm for coarsening a graph with uncoupled aggregation. creates aggregates along an interface using specified root nodes. More... | |
class | OnePtAggregationAlgorithm |
Algorithm for coarsening a graph with uncoupled aggregation. keep special marked nodes as singleton node aggregates over all multigrid levels. More... | |
class | PreserveDirichletAggregationAlgorithm |
Builds one-to-one aggregates for all Dirichlet boundary nodes. For some applications this might be necessary. (default = off) More... | |
class | UncoupledAggregationFactory |
Factory for building uncoupled aggregates. More... | |
class | UserAggregationFactory |
class | FacadeBGS2x2 |
class | FacadeClassBase |
class | FacadeClassFactory |
class | FacadeSimple |
class | AdaptiveSaMLParameterListInterpreter |
class | FactoryFactory |
Factory that can generate other factories from. More... | |
class | HierarchyFactory |
class | HierarchyManager |
class | ML2MueLuParameterTranslator |
Class that accepts ML-style parameters and builds a MueLu parameter list (easy input deck) More... | |
class | MLParameterListInterpreter |
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. More... | |
class | ParameterListInterpreter |
class | BlockedCoordinatesTransferFactory |
Class for transferring coordinates from a finer level to a coarser one for BlockedCrsMatrices. This basically combines the Coordinates generated by each separate block. More... | |
class | BlockedRAPFactory |
Factory for building coarse matrices. More... | |
class | CoordinatesTransferFactory |
Class for transferring coordinates from a finer level to a coarser one. More... | |
class | DemoFactory |
empty factory for demonstration More... | |
class | DropNegativeEntriesFactory |
Application-specific filtering for A. Can be used in context of graph coarsening and aggregation. More... | |
class | FilteredAFactory |
Factory for building filtered matrices using filtered graphs. More... | |
class | FineLevelInputDataFactory |
class | InitialBlockNumberFactory |
Class for generating an initial LocalOrdinal-type BlockNumber vector, based on an input paraemter for interleaved dofs. More... | |
class | InterfaceAggregationFactory |
Factory for building aggregates for Lagrange multipliers in surface-coupled problems. More... | |
class | InterfaceMappingTransferFactory |
Transfer mapping data for interface aggregation to the coarse level. More... | |
class | InverseApproximationFactory |
Factory for building the approximate inverse of a matrix. More... | |
class | LineDetectionFactory |
Factory for building line detection information. More... | |
class | LocalOrdinalTransferFactory |
Class for transferring a vector of local ordinals from a finer level to a coarser one, where each aggregate has a unique one. More... | |
class | LowPrecisionFactory |
Factory for converting matrices to half precision operators. More... | |
class | MapTransferFactory |
Factory to transfer a map from a fine to a coarse level. More... | |
class | MergedBlockedMatrixFactory |
class | MultiVectorTransferFactory |
Class for restricting a MultiVector from a finer to a coarser level. More... | |
class | RAPFactory |
Factory for building coarse matrices. More... | |
class | RAPShiftFactory |
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. More... | |
class | SchurComplementFactory |
Factory for building the Schur Complement for a 2x2 block matrix. More... | |
class | SegregatedAFactory |
Factory for building a new "segregated" A operator. Here, "segregated" means that the user provides some map(s) (containing a subset of GIDs of the input matrix A) and the factory drops entries depending on the dropping scheme. More... | |
class | StructuredLineDetectionFactory |
Factory building line detection information on structured meshes. More... | |
class | ThresholdAFilterFactory |
Factory for building a thresholded operator. More... | |
class | BaseClass |
Base class for MueLu classes. More... | |
class | Describable |
Base class for MueLu classes. More... | |
class | Factory |
class | FactoryAcceptor |
class | FactoryBase |
Base class for factories (e.g., R, P, and A_coarse). More... | |
class | FactoryManager |
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. More... | |
class | FactoryManagerBase |
Class that provides default factories within Needs class. More... | |
class | Hierarchy |
Provides methods to build a multigrid hierarchy and apply multigrid cycles. More... | |
class | SetFactoryManager |
An exception safe way to call the method 'Level::SetFactoryManager()'. More... | |
class | HierarchyUtils |
class | Level |
Class that holds all level-specific information. More... | |
class | DefaultProblemStrings |
Helper class to initialize DefaultProblemTypeLists_ in class MasterList. More... | |
class | MasterList |
Static class that holds the complete list of valid MueLu parameters. More... | |
class | NoFactory |
NoFactory that is used for data stored in level class for that no generating factory is available/necessary. More... | |
class | ParameterListAcceptor |
Abstract interface of a class accepting parameter lists. More... | |
class | ParameterListAcceptorImpl |
class | SingleLevelFactoryBase |
Base class for factories that use one level (currentLevel). More... | |
class | TopRAPFactory |
class | TopSmootherFactory |
class | TwoLevelFactoryBase |
Base class for factories that use two levels (fineLevel and coarseLevel). More... | |
class | VariableContainer |
Class that stores all relevant data for a variable. More... | |
class | VerboseObject |
Verbose class for MueLu classes. More... | |
class | Maxwell1 |
Preconditioner (wrapped as a Xpetra::Operator) for Maxwell's equations in curl-curl form. More... | |
class | Maxwell_Utils |
Utility functions for Maxwell. More... | |
class | MultiPhys |
Preconditioner (wrapped as a Xpetra::Operator) for solving MultiPhysics PDEs. More... | |
class | RefMaxwell |
Preconditioner (wrapped as a Xpetra::Operator) for Maxwell's equations in curl-curl form. More... | |
class | XpetraOperator |
Wraps an existing MueLu::Hierarchy as a Xpetra::Operator. More... | |
class | CloneRepartitionInterface |
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. More... | |
class | IsorropiaInterface |
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. More... | |
class | NodePartitionInterface |
Partitioning within a node onlyThis interface provides partitioning within a node. More... | |
class | RebalanceAcFactory |
Factory for building coarse matrices. More... | |
class | RebalanceBlockAcFactory |
class | RebalanceBlockInterpolationFactory |
Applies permutation to prolongation operators. More... | |
class | RebalanceBlockRestrictionFactory |
Applies permutation to restriction operators. More... | |
class | RebalanceMapFactory |
Factory which rebalances a map on current level using the Importer object generated by the RepartitionFactory. More... | |
class | RebalanceTransferFactory |
Applies permutation to grid transfer operators. More... | |
class | RepartitionBlockDiagonalFactory |
Factory which rebalances a map on current level using the Importer object generated by the RepartitionFactory. More... | |
class | RepartitionFactory |
Factory for building permutation matrix that can be be used to shuffle data (matrices, vectors) among processes. More... | |
struct | Triplet |
class | RepartitionHeuristicFactory |
Factory for determing the number of partitions for rebalancing. More... | |
class | RepartitionInterface |
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. More... | |
class | Zoltan2Interface |
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. More... | |
class | Zoltan2Interface< double, int, int, Xpetra::EpetraNode > |
class | ZoltanInterface |
Interface to Zoltan library.This interface provides access to partitioning methods in Zoltan. Currently, it supports the RCB algorithm only. More... | |
class | BlockedDirectSolver |
direct solver for nxn blocked matrices More... | |
class | BlockedGaussSeidelSmoother |
block Gauss-Seidel method for blocked matrices More... | |
class | BlockedJacobiSmoother |
block Jacobi method for blocked matrices More... | |
class | BraessSarazinSmoother |
BraessSarazin smoother for 2x2 block matrices. More... | |
class | IndefBlockedDiagonalSmoother |
Cheap Blocked diagonal smoother for indefinite 2x2 block matrices. More... | |
class | SimpleSmoother |
SIMPLE smoother for 2x2 block matrices. More... | |
class | TekoSmoother |
Interface to block smoothers in Teko package. More... | |
class | TekoSmoother< double, int, GlobalOrdinal, Node > |
class | UzawaSmoother |
Block triangle Uzawa smoother for 2x2 block matrices. More... | |
class | AdvSmootherPrototype |
class | Projection |
class | Amesos2Smoother |
Class that encapsulates Amesos2 direct solvers. More... | |
class | Amesos2Smoother< double, int, int, Xpetra::EpetraNode > |
class | AmesosSmoother |
Class that encapsulates Amesos direct solvers. More... | |
class | BelosSmoother |
Class that encapsulates Belos smoothers. More... | |
class | BelosSmoother< double, int, int, Xpetra::EpetraNode > |
class | DirectSolver |
Class that encapsulates direct solvers. Autoselection of AmesosSmoother or Amesos2Smoother according to the compile time configuration of Trilinos. More... | |
class | Ifpack2Smoother |
Class that encapsulates Ifpack2 smoothers. More... | |
class | Ifpack2Smoother< double, int, int, Xpetra::EpetraNode > |
class | IfpackSmoother |
Class that encapsulates Ifpack smoothers. More... | |
class | MergedSmoother |
class | PermutingSmoother |
This class first calculates row- and column permutation operators and applies a smoother to the permuted linear system. More... | |
class | ProjectorSmoother |
This class enables the elimination of the nullspace component of the solution through the use of projection. More... | |
class | RefMaxwellSmoother |
Class that encapsulates Operator smoothers. More... | |
class | SmootherBase |
Base class for smoothers. More... | |
class | SmootherFactory |
Generic Smoother Factory for generating the smoothers of the MG hierarchy. More... | |
class | SmootherFactoryBase |
class | SmootherPrototype |
Base class for smoother prototypes. More... | |
class | TrilinosSmoother |
Class that encapsulates external library smoothers. More... | |
class | PFactory |
Factory that provides an interface for a concrete implementation of a prolongation operator. More... | |
class | BlackBoxPFactory |
Prolongator factory performing geometric coarsening. More... | |
class | BlockedCoarseMapFactory |
Factory for generating coarse level map. Used by BlockedPFactory. More... | |
class | BlockedPFactory |
Factory for building blocked, segregated prolongation operators. More... | |
class | ReorderBlockAFactory |
Factory for building a reordered (nested) block operator. More... | |
class | SubBlockAFactory |
Factory for building a thresholded operator. More... | |
class | ZeroSubBlockAFactory |
Factory for extracting a zero block from a BlockedCrsMatrix. More... | |
class | ClassicalMapFactory |
Factory for generating F/C-splitting and a coarse level map. Used by ClassicalPFactory. More... | |
class | ClassicalPFactory |
class | Constraint |
Constraint space information for the potential prolongator. More... | |
class | ConstraintFactory |
Factory for building the constraint operator. More... | |
class | EminPFactory |
Factory for building Energy Minimization prolongators. More... | |
class | NullspacePresmoothFactory |
class | PatternFactory |
Factory for building nonzero patterns for energy minimization. More... | |
class | CGSolver |
Implements conjugate gradient algorithm for energy-minimization. More... | |
class | GMRESSolver |
Implements conjugate gradient algorithm for energy-minimization. More... | |
class | SolverBase |
Base class for energy-minimization iterative solvers. More... | |
class | SteepestDescentSolver |
Implements steepest descent algorithm for energy-minimization. More... | |
class | GeneralGeometricPFactory |
Prolongator factory performing geometric coarsening. More... | |
class | GeometricInterpolationPFactory |
class | GeometricInterpolationPFactory_kokkos |
class | RegionRFactory |
Factory that builds a restriction operator for region multigrid. More... | |
class | RegionRFactory_kokkos |
Factory that builds a restriction operator for region multigrid. More... | |
class | CombinePFactory |
Prolongator factory that replicates 'Psubblock' matrix to create new prolongator suitable for PDE systems. More... | |
class | GenericRFactory |
Factory for building restriction operators using a prolongator factory. More... | |
class | ReplicatePFactory |
Prolongator factory that replicates 'Psubblock' matrix to create new prolongator suitable for PDE systems. More... | |
class | RfromP_Or_TransP |
Factory for building restriction operators. More... | |
class | TransPFactory |
Factory for building restriction operators. More... | |
class | GeoInterpFactory |
Factory for GMG Q2-Q1-Q2 interpolation. More... | |
class | MHDRAPFactory |
Factory for building coarse matrices. More... | |
class | Q2Q1Q2CoarseGridFactory |
Factory for GMG Q2-Q1-Q2 interpolation. More... | |
class | MatrixFreeTentativeP |
Matrix-free tentative restrictor operator. More... | |
class | MatrixFreeTentativePFactory |
Factory for building the matrix-free tentative restrictor. More... | |
class | IntrepidPCoarsenFactory |
Factory for building transfer operators based on coarsening in polynomial degree, following the Intrepid basis functions. More... | |
class | PgPFactory |
Factory for building Petrov-Galerkin Smoothed Aggregation prolongators. More... | |
class | SemiCoarsenPFactory |
Prolongator factory performing semi-coarsening. More... | |
class | SemiCoarsenPFactory_kokkos |
Prolongator factory performing semi-coarsening. More... | |
class | ToggleCoordinatesTransferFactory |
Class for transferring coordinates from a finer level to a coarser one. More... | |
class | TogglePFactory |
Prolongator factory which allows switching between two different prolongator strategies. More... | |
class | CoarseMapFactory |
Factory for generating coarse level map. Used by TentativePFactory. More... | |
class | NullspaceFactory |
Factory for generating nullspace. More... | |
class | NullspaceFunctor |
class | NullspaceFactory_kokkos |
class | ReitzingerPFactory |
Factory for building tentative prolongator. More... | |
class | SaPFactory |
Factory for building Smoothed Aggregation prolongators.Input/output of SaPFactoryMore... | |
struct | constraintKernel |
struct | optimalSatisfyConstraintsForScalarPDEsKernel |
class | SaPFactory_kokkos |
class | ScaledNullspaceFactory |
Factory for generating a very special nullspace. More... | |
class | TentativePFactory |
Factory for building tentative prolongator. More... | |
class | TentativePFactory_kokkos |
class | UserPFactory |
class | AggregateQualityEstimateFactory |
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. More... | |
class | AggregationExportFactory |
Factory to export aggregation info or visualize aggregates using VTK. More... | |
class | AlgebraicPermutationStrategy |
Algebraic permutation strategy. More... | |
class | AMGXOperator |
Adapter for AmgX library from Nvidia. More... | |
class | CoarseningVisualizationFactory |
Factory to visualize coarsening information using prolongation operators. More... | |
class | CoupledRBMFactory |
Nullspace Factory for coupled acoustic-elastic problems. More... | |
class | FakeSmootherPrototype |
class | Graph |
class | GraphBase |
class | LeftoverAggregationAlgorithm |
class | LocalAggregationAlgorithm |
class | LocalPermutationStrategy |
Local permutation strategy. More... | |
class | MatlabSmoother |
Class that encapsulates Matlab smoothers. More... | |
class | MatrixAnalysisFactory |
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. More... | |
class | ParameterListIntepreter |
class | PerfModels |
class | PerfUtils |
class | PermutationFactory |
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. More... | |
class | PRFactory |
class | RigidBodyModeFactory |
Nullspace Factory for building rigid body modes. More... | |
class | SingleLevelMatlabFactory |
Factory for interacting with Matlab. More... | |
class | Smoother |
Base class for smoother factories. More... | |
class | TpetraOperator |
Wraps an existing MueLu::Hierarchy as a Tpetra::Operator. More... | |
class | TwoLevelMatlabFactory |
Factory for interacting with Matlab. More... | |
class | Utilities |
MueLu utility class. More... | |
class | UtilitiesBase |
MueLu utility class. More... | |
class | VisualizationHelpers |
Base class providing routines to visualize aggregates and coarsening information. More... | |
struct | CompPairs |
class | DisableMultipleCallCheck |
An exception safe way to call the method TwoLevelFactoryBase::DisableMultipleCallCheck. More... | |
struct | FormattingHelper |
class | PrintMonitor |
class | Monitor |
Timer to be used in non-factories. More... | |
class | SubMonitor |
Timer to be used in non-factories. Similar to Monitor, but doesn't print object description. More... | |
class | FactoryMonitor |
Timer to be used in factories. Similar to Monitor but with additional timers. More... | |
class | SubFactoryMonitor |
Timer to be used in factories. Similar to SubMonitor but adds a timer level by level. More... | |
class | MutuallyExclusiveTime |
This class wraps a Teuchos::Time and maintains a mutually exclusive property between wrapped timers. More... | |
class | TimeMonitor |
Integrates Teuchos::TimeMonitor with MueLu verbosity system. More... | |
class | MutuallyExclusiveTimeMonitor |
Similar to TimeMonitor, but uses MutuallyExclusiveTime objects. More... | |
class | Utilities< double, int, int, Xpetra::EpetraNode > |
struct | AppendTrait |
struct | CombineMemoryTraits |
struct | CombineMemoryTraits< Kokkos::MemoryTraits< U >, T > |
struct | AppendTrait< Kokkos::View< DataType, Pack...>, T > |
class | myTriangle |
class | myVec3 |
class | myVec2 |
class | AMGXOperator< double, int, int, Node > |
class | ShiftedLaplacian |
Shifted Laplacian Helmholtz solver. More... | |
class | ShiftedLaplacianOperator |
Wraps an existing MueLu::Hierarchy as a Tpetra::Operator, with an optional two-level correction. Intended to be used with MueLu::ShiftedLaplacian. More... | |
class | TpetraOperatorAsRowMatrix |
class | MuemexArg |
class | MuemexData |
Enumerations | |
enum | decisionAlgoType { defaultAlgo, unscaled_cut, scaled_cut, scaled_cut_symmetric } |
enum | CycleType { VCYCLE, WCYCLE } |
enum | PreOrPost { PRE = 0x1, POST = 0x2, BOTH = 0x3 } |
enum | NodeState { READY = 1, NOTSEL = 2, AGGREGATED = 3, ONEPT = 4, IGNORED = 5, BOUNDARY = 6, INTERFACE = 7 } |
enum | IndexingType { UNCOUPLED = 1, LOCALLEXI = 2, GLOBALLEXI = 3 } |
enum | ConvergenceStatus { ConvergenceStatus::Converged, ConvergenceStatus::Unconverged, ConvergenceStatus::Undefined } |
enum | KeepEnum { UserData = 0x1, Keep = 0x2, Final = 0x4, NextRun = UserData | Keep, All = UserData | Keep | Final } |
Keep status of a variable of Level. More... | |
enum | MsgType { Errors = 0x00000001, Warnings0 = 0x00000010, Warnings00 = 0x00000020, Warnings1 = 0x00000040, PerfWarnings = 0x00000080, Runtime0 = 0x00000100, Runtime1 = 0x00000200, RuntimeTimings = 0x00000400, NoTimeReport = 0x00000800, Parameters0 = 0x00001000, Parameters1 = 0x00002000, Statistics0 = 0x00010000, Statistics1 = 0x00020000, Statistics2 = 0x00040000, Timings0 = 0x00100000, Timings1 = 0x00200000, TimingsByLevel = 0x00400000, External = 0x01000000, Debug = 0x02000000, Developer = 0x04000000, Test0 = 0x10000000, Test1 = 0x20000000, Warnings = Warnings0 | Warnings00 | Warnings1 | PerfWarnings, Runtime = Runtime0 | Runtime1, Parameters = Parameters0 | Parameters1, Statistics = Statistics0 | Statistics1 | Statistics2, Timings = Timings0 | Timings1 | TimingsByLevel, Test = Test0 | Test1 | Runtime0, InterfaceTest = Test0 | Runtime0, None = 0, Low = Errors | Warnings0 | Statistics0, Medium = Errors | Warnings0 | Runtime0 | Parameters0 | Statistics0 | Statistics1 | Timings0, High = Errors | Warnings | Runtime | Parameters | Statistics0 | Statistics1 | Timings, Extreme = Errors | Warnings | Runtime | Parameters | Statistics | Timings | External | Developer, Default = High, NotSpecified = -1 } |
enum | MinimizationNorm { ANORM = 0, L2NORM = 1, DINVANORM = 2 } |
enum | MuemexType { INT, BOOL, DOUBLE, COMPLEX, STRING, XPETRA_MAP, XPETRA_ORDINAL_VECTOR, TPETRA_MULTIVECTOR_DOUBLE, TPETRA_MULTIVECTOR_COMPLEX, TPETRA_MATRIX_DOUBLE, TPETRA_MATRIX_COMPLEX, XPETRA_MATRIX_DOUBLE, XPETRA_MATRIX_COMPLEX, XPETRA_MULTIVECTOR_DOUBLE, XPETRA_MULTIVECTOR_COMPLEX, EPETRA_CRSMATRIX, EPETRA_MULTIVECTOR, AGGREGATES, AMALGAMATION_INFO, GRAPH } |
Functions | |
std::string const | Version () |
static void | ML_OverwriteDefaults (ParameterList &inList, ParameterList &List, bool OverWrite) |
static int | UpdateList (Teuchos::ParameterList &source, Teuchos::ParameterList &dest, bool OverWrite) |
void | CreateSublists (const ParameterList &List, ParameterList &newList) |
size_t | LevenshteinDistance (const char *s, size_t len_s, const char *t, size_t len_t) |
static bool | areSame (const ParameterList &list1, const ParameterList &list2) |
Helper functions to compare two paramter lists. More... | |
static bool | compare (const ParameterList &list1, const ParameterList &list2) |
void | MergeParameterList (const Teuchos::ParameterList &source, Teuchos::ParameterList &dest, bool overWrite) |
: merge two parameter lists More... | |
const Teuchos::ParameterList & | GetMLSubList (const Teuchos::ParameterList ¶mList, const std::string &type, int levelID) |
Teuchos::RCP < Teuchos::ParameterList > | ExtractSetOfParameters (const Teuchos::ParameterList ¶mList, const std::string &str) |
void | replaceAll (std::string &str, const std::string &from, const std::string &to) |
template<typename Type > | |
bool | replacePlaceholder (std::string &str, const std::string &placeholder, Type data) |
templated version to replace placeholder by data in "str" More... | |
template<typename Type > | |
bool | actionInterpretParameter (Teuchos::ParameterList &mlParams, const std::string ¶mName, std::string &str) |
template<class T > | |
void | sort_and_unique (T &array) |
void | printParameterListOptions (std::ostream &os, const Teuchos::ParameterList &p) |
VerbLevel | toMueLuVerbLevel (const Teuchos::EVerbosityLevel verbLevel) |
Translate Teuchos verbosity level to MueLu verbosity level. More... | |
std::string | lowerCase (const std::string &s) |
MsgType | toVerbLevel (const std::string &verbLevelStr) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< MueLu::Hierarchy < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | CreateXpetraPreconditioner (Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> op, const Teuchos::ParameterList &inParamList) |
Helper function to create a MueLu preconditioner that can be used by Xpetra.Given an Xpetra::Matrix, this function returns a constructed MueLu preconditioner. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< MueLu::Hierarchy < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | CreateXpetraPreconditioner (Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> op, const std::string &xmlFileName) |
Helper function to create a MueLu preconditioner that can be used by Xpetra.Given an Xpetra::Matrix, this function returns a constructed MueLu preconditioner. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< MueLu::Hierarchy < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | CreateXpetraPreconditioner (Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> op) |
Helper function to create a MueLu preconditioner that can be used by Xpetra.Given an Xpetra::Matrix, this function returns a constructed MueLu preconditioner. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
void | ReuseXpetraPreconditioner (const Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &A, Teuchos::RCP< MueLu::Hierarchy< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &H) |
Helper function to reuse an existing MueLu preconditioner. More... | |
template<typename T > | |
T | pop (Teuchos::ParameterList &pl, std::string const &name_in) |
template<typename T > | |
T | pop (Teuchos::ParameterList &pl, std::string const &name_in, T def_value) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP < Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Matrix2CrsMatrix (Teuchos::RCP< Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &matrix) |
template<typename T , typename W > | |
static bool | compareTriplets (const Triplet< T, W > &a, const Triplet< T, W > &b) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< MueLu::SmootherPrototype < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | GetAmesosSmoother (const std::string &="", const Teuchos::ParameterList &=Teuchos::ParameterList()) |
Non-member templated function GetAmesosSmoother() returns a new AmesosSmoother object. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< MueLu::SmootherPrototype < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | GetIfpackSmoother (const std::string &="", const Teuchos::ParameterList &=Teuchos::ParameterList(), const LocalOrdinal &=0) |
template<> | |
RCP< MueLu::SmootherPrototype < double, int, int, Xpetra::EpetraNode > > | GetIfpackSmoother< double, int, int, Xpetra::EpetraNode > (const std::string &type, const Teuchos::ParameterList ¶mList, const int &overlap) |
template<class Scalar , class LocalOrdinal > | |
CompPairs< Scalar, LocalOrdinal > | CreateCmpPairs (const std::vector< Scalar > &v) |
template<class Scalar , class LocalOrdinal > | |
void | sortingPermutation (const std::vector< Scalar > &values, std::vector< LocalOrdinal > &v) |
template<class Type > | |
void | calculateStats (Type &minVal, Type &maxVal, double &avgVal, double &devVal, int &minProc, int &maxProc, const RCP< const Teuchos::Comm< int > > &comm, int numActiveProcs, const Type &v) |
template<class Type > | |
std::string | stringStats (const RCP< const Teuchos::Comm< int > > &comm, int numActiveProcs, const Type &v, RCP< ParameterList > paramList=Teuchos::null) |
template<class Map > | |
bool | cmp_less (typename Map::value_type &v1, typename Map::value_type &v2) |
long | ExtractNonSerializableData (const Teuchos::ParameterList &inList, Teuchos::ParameterList &serialList, Teuchos::ParameterList &nonSerialList) |
Extract non-serializable data from level-specific sublists and move it to a separate parameter list. More... | |
void | TokenizeStringAndStripWhiteSpace (const std::string &stream, std::vector< std::string > &tokenList, const char *delimChars) |
bool | IsParamMuemexVariable (const std::string &name) |
bool | IsParamValidVariable (const std::string &name) |
Teuchos::RCP< const Teuchos::Comm< int > > | GenerateNodeComm (RCP< const Teuchos::Comm< int > > &baseComm, int &NodeId, const int reductionFactor) |
template<typename SC , typename LO , typename GO , typename NO > | |
RCP< Xpetra::CrsMatrixWrap< SC, LO, GO, NO > > | Convert_Epetra_CrsMatrix_ToXpetra_CrsMatrixWrap (RCP< Epetra_CrsMatrix > &epAB) |
template<typename SC , typename LO , typename GO , typename NO > | |
RCP< Xpetra::Matrix< SC, LO, GO, NO > > | EpetraCrs_To_XpetraMatrix (const Teuchos::RCP< Epetra_CrsMatrix > &A) |
template<typename SC , typename LO , typename GO , typename NO > | |
RCP< Xpetra::MultiVector< SC, LO, GO, NO > > | EpetraMultiVector_To_XpetraMultiVector (const Teuchos::RCP< Epetra_MultiVector > &V) |
template<typename SC , typename LO , typename GO , typename NO > | |
RCP< Xpetra::Matrix< SC, LO, GO, NO > > | TpetraCrs_To_XpetraMatrix (const Teuchos::RCP< Tpetra::CrsMatrix< SC, LO, GO, NO >> &Atpetra) |
template<typename SC , typename LO , typename GO , typename NO > | |
RCP< Xpetra::Matrix< SC, LO, GO, NO > > | TpetraFECrs_To_XpetraMatrix (const Teuchos::RCP< Tpetra::FECrsMatrix< SC, LO, GO, NO >> &Atpetra) |
template<typename SC , typename LO , typename GO , typename NO > | |
RCP< Xpetra::MultiVector< SC, LO, GO, NO > > | TpetraMultiVector_To_XpetraMultiVector (const Teuchos::RCP< Tpetra::MultiVector< SC, LO, GO, NO >> &Vtpetra) |
template<typename SC , typename LO , typename GO , typename NO > | |
RCP< Xpetra::MultiVector< SC, LO, GO, NO > > | TpetraFEMultiVector_To_XpetraMultiVector (const Teuchos::RCP< Tpetra::FEMultiVector< SC, LO, GO, NO >> &Vtpetra) |
template<typename SC , typename LO , typename GO , typename NO > | |
void | leftRghtDofScalingWithinNode (const Xpetra::Matrix< SC, LO, GO, NO > &Atpetra, size_t blkSize, size_t nSweeps, Teuchos::ArrayRCP< SC > &rowScaling, Teuchos::ArrayRCP< SC > &colScaling) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > | importOffRankDroppingInfo (Teuchos::RCP< const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node >> &localDropMap, Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &Ain) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | EpetraCrs_To_XpetraMatrix (const Teuchos::RCP< Epetra_CrsMatrix > &A) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< Xpetra::MultiVector < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | EpetraMultiVector_To_XpetraMultiVector (const Teuchos::RCP< Epetra_MultiVector > &V) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | TpetraCrs_To_XpetraMatrix (const Teuchos::RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &Atpetra) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | TpetraFECrs_To_XpetraMatrix (const Teuchos::RCP< Tpetra::FECrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &Atpetra) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< Xpetra::MultiVector < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | TpetraMultiVector_To_XpetraMultiVector (const Teuchos::RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &Vtpetra) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
RCP< Xpetra::MultiVector < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | TpetraFEMultiVector_To_XpetraMultiVector (const Teuchos::RCP< Tpetra::FEMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &Vtpetra) |
template<class T > | |
std::string | toString (const T &what) |
Little helper function to convert non-string types to strings. More... | |
Teuchos::RCP< const Teuchos::Comm< int > > | GenerateNodeComm (RCP< const Teuchos::Comm< int >> &baseComm, int &NodeId, const int reductionFactor) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< Xpetra::Matrix < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | removeSmallEntries (Teuchos::RCP< Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &A, const typename Teuchos::ScalarTraits< Scalar >::magnitudeType threshold, const bool keepDiagonal) |
template<class SC , class LO , class GO , class NO , class memory_space > | |
Kokkos::View< bool *, memory_space > | DetectDirichletRows_kokkos (const Xpetra::Matrix< SC, LO, GO, NO > &A, const typename Teuchos::ScalarTraits< SC >::magnitudeType &tol, const bool count_twos_as_dirichlet) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node , class memory_space > | |
void | ApplyRowSumCriterion (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const typename Teuchos::ScalarTraits< Scalar >::magnitudeType rowSumTol, Kokkos::View< bool *, memory_space > &dirichletRows) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node , class memory_space > | |
void | ApplyRowSumCriterion (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Xpetra::Vector< LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > &BlockNumber, const typename Teuchos::ScalarTraits< Scalar >::magnitudeType rowSumTol, Kokkos::View< bool *, memory_space > &dirichletRows) |
void | MueLu_AMGX_initialize () |
void | MueLu_AMGX_initialize_plugins () |
void | MueLu_AMGX_finalize () |
void | MueLu_AMGX_finalize_plugins () |
Teuchos::RCP < MueLu::EpetraOperator > | CreateEpetraPreconditioner (const Teuchos::RCP< Epetra_CrsMatrix > &inA, Teuchos::ParameterList ¶mListIn) |
Helper function to create a MueLu preconditioner that can be used by Epetra.Given a EpetraCrs_Matrix, this function returns a constructed MueLu preconditioner. More... | |
Teuchos::RCP < MueLu::EpetraOperator > | CreateEpetraPreconditioner (const Teuchos::RCP< Epetra_CrsMatrix > &A, const std::string &xmlFileName) |
Helper function to create a MueLu preconditioner that can be used by Epetra.Given a Epetra_CrsMatrix, this function returns a constructed MueLu preconditioner. More... | |
Teuchos::RCP < MueLu::EpetraOperator > | CreateEpetraPreconditioner (const Teuchos::RCP< Epetra_CrsMatrix > &A) |
Helper function to create a MueLu preconditioner that can be used by Epetra.Given a Epetra_CrsMatrix, this function returns a constructed MueLu preconditioner. More... | |
void | ReuseEpetraPreconditioner (const Teuchos::RCP< Epetra_CrsMatrix > &inA, MueLu::EpetraOperator &Op) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP < MueLu::TpetraOperator < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | CreateTpetraPreconditioner (const Teuchos::RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &inA, Teuchos::ParameterList &inParamList) |
Helper function to create a MueLu or AMGX preconditioner that can be used by Tpetra.Given a Tpetra::Operator, this function returns a constructed MueLu preconditioner. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP < MueLu::TpetraOperator < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | CreateTpetraPreconditioner (const Teuchos::RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &inA, const std::string &xmlFileName) |
Helper function to create a MueLu preconditioner that can be used by Tpetra.Given a Tpetra::Operator, this function returns a constructed MueLu preconditioner. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP < MueLu::TpetraOperator < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | CreateTpetraPreconditioner (const Teuchos::RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &inA) |
Helper function to create a MueLu preconditioner that can be used by Tpetra.Given a Tpetra::Operator, this function returns a constructed MueLu preconditioner. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
void | ReuseTpetraPreconditioner (const Teuchos::RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &inA, MueLu::TpetraOperator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op) |
Helper function to reuse an existing MueLu preconditioner. More... | |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
void | ReuseTpetraPreconditioner (const Teuchos::RCP< Tpetra::BlockCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &inA, MueLu::TpetraOperator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op) |
int * | mwIndex_to_int (int N, mwIndex *mwi_array) |
template<> | |
mxArray * | createMatlabSparse< double > (int numRows, int numCols, int nnz) |
template<> | |
mxArray * | createMatlabSparse< complex_t > (int numRows, int numCols, int nnz) |
template<> | |
void | fillMatlabArray< double > (double *array, const mxArray *mxa, int n) |
template<> | |
void | fillMatlabArray< complex_t > (complex_t *array, const mxArray *mxa, int n) |
void | callMatlabNoArgs (std::string function) |
std::vector< RCP< MuemexArg > > | callMatlab (std::string function, int numOutputs, std::vector< RCP< MuemexArg > > args) |
template<> | |
mxArray * | createMatlabMultiVector< double > (int numRows, int numCols) |
template<> | |
mxArray * | createMatlabMultiVector< complex_t > (int numRows, int numCols) |
mxArray * | saveAmalInfo (RCP< MAmalInfo > &amalInfo) |
bool | isValidMatlabAggregates (const mxArray *mxa) |
bool | isValidMatlabGraph (const mxArray *mxa) |
std::vector< std::string > | tokenizeList (const std::string ¶ms) |
Teuchos::RCP < Teuchos::ParameterList > | getInputParamList () |
Teuchos::RCP< MuemexArg > | convertMatlabVar (const mxArray *mxa) |
template bool | loadDataFromMatlab< bool > (const mxArray *mxa) |
template int | loadDataFromMatlab< int > (const mxArray *mxa) |
template double | loadDataFromMatlab< double > (const mxArray *mxa) |
template complex_t | loadDataFromMatlab< complex_t > (const mxArray *mxa) |
template string | loadDataFromMatlab< string > (const mxArray *mxa) |
template RCP < Xpetra_ordinal_vector > | loadDataFromMatlab< RCP< Xpetra_ordinal_vector > > (const mxArray *mxa) |
template RCP < Tpetra_MultiVector_double > | loadDataFromMatlab< RCP< Tpetra_MultiVector_double > > (const mxArray *mxa) |
template RCP < Tpetra_MultiVector_complex > | loadDataFromMatlab< RCP< Tpetra_MultiVector_complex > > (const mxArray *mxa) |
template RCP < Tpetra_CrsMatrix_double > | loadDataFromMatlab< RCP< Tpetra_CrsMatrix_double > > (const mxArray *mxa) |
template RCP < Tpetra_CrsMatrix_complex > | loadDataFromMatlab< RCP< Tpetra_CrsMatrix_complex > > (const mxArray *mxa) |
template RCP < Xpetra_Matrix_double > | loadDataFromMatlab< RCP< Xpetra_Matrix_double > > (const mxArray *mxa) |
template RCP < Xpetra_Matrix_complex > | loadDataFromMatlab< RCP< Xpetra_Matrix_complex > > (const mxArray *mxa) |
template RCP < Xpetra_MultiVector_double > | loadDataFromMatlab< RCP< Xpetra_MultiVector_double > > (const mxArray *mxa) |
template RCP < Xpetra_MultiVector_complex > | loadDataFromMatlab< RCP< Xpetra_MultiVector_complex > > (const mxArray *mxa) |
template RCP< Epetra_CrsMatrix > | loadDataFromMatlab< RCP< Epetra_CrsMatrix > > (const mxArray *mxa) |
template RCP< Epetra_MultiVector > | loadDataFromMatlab< RCP< Epetra_MultiVector > > (const mxArray *mxa) |
template RCP< MAggregates > | loadDataFromMatlab< RCP< MAggregates > > (const mxArray *mxa) |
template RCP< MAmalInfo > | loadDataFromMatlab< RCP< MAmalInfo > > (const mxArray *mxa) |
template mxArray * | saveDataToMatlab (bool &data) |
template mxArray * | saveDataToMatlab (int &data) |
template mxArray * | saveDataToMatlab (double &data) |
template mxArray * | saveDataToMatlab (complex_t &data) |
template mxArray * | saveDataToMatlab (string &data) |
template mxArray * | saveDataToMatlab (RCP< Xpetra_ordinal_vector > &data) |
template mxArray * | saveDataToMatlab (RCP< Tpetra_MultiVector_double > &data) |
template mxArray * | saveDataToMatlab (RCP< Tpetra_MultiVector_complex > &data) |
template mxArray * | saveDataToMatlab (RCP< Tpetra_CrsMatrix_double > &data) |
template mxArray * | saveDataToMatlab (RCP< Tpetra_CrsMatrix_complex > &data) |
template mxArray * | saveDataToMatlab (RCP< Xpetra_Matrix_double > &data) |
template mxArray * | saveDataToMatlab (RCP< Xpetra_Matrix_complex > &data) |
template mxArray * | saveDataToMatlab (RCP< Xpetra_MultiVector_double > &data) |
template mxArray * | saveDataToMatlab (RCP< Xpetra_MultiVector_complex > &data) |
template mxArray * | saveDataToMatlab (RCP< Epetra_CrsMatrix > &data) |
template mxArray * | saveDataToMatlab (RCP< Epetra_MultiVector > &data) |
template mxArray * | saveDataToMatlab (RCP< MAggregates > &data) |
template mxArray * | saveDataToMatlab (RCP< MAmalInfo > &data) |
template vector< RCP< MuemexArg > > | processNeeds< double > (const Factory *factory, string &needsParam, Level &lvl) |
template vector< RCP< MuemexArg > > | processNeeds< complex_t > (const Factory *factory, string &needsParam, Level &lvl) |
template void | processProvides< double > (vector< RCP< MuemexArg > > &mexOutput, const Factory *factory, string &providesParam, Level &lvl) |
template void | processProvides< complex_t > (vector< RCP< MuemexArg > > &mexOutput, const Factory *factory, string &providesParam, Level &lvl) |
template<typename T > | |
MuemexType | getMuemexType (const T &data) |
template<typename T > | |
MuemexType | getMuemexType () |
template<typename T > | |
T | loadDataFromMatlab (const mxArray *mxa) |
template<typename T > | |
mxArray * | saveDataToMatlab (T &data) |
template<typename T > | |
void | addLevelVariable (const T &data, std::string &name, Level &lvl, const FactoryBase *fact=NoFactory::get()) |
template<typename T > | |
const T & | getLevelVariable (std::string &name, Level &lvl) |
template<typename Scalar = double, typename LocalOrdinal = mm_LocalOrd, typename GlobalOrdinal = mm_GlobalOrd, typename Node = mm_node_t> | |
std::vector< Teuchos::RCP < MuemexArg > > | processNeeds (const Factory *factory, std::string &needsParam, Level &lvl) |
template<typename Scalar = double, typename LocalOrdinal = mm_LocalOrd, typename GlobalOrdinal = mm_GlobalOrd, typename Node = mm_node_t> | |
void | processProvides (std::vector< Teuchos::RCP< MuemexArg > > &mexOutput, const Factory *factory, std::string &providesParam, Level &lvl) |
template<typename Scalar > | |
mxArray * | createMatlabSparse (int numRows, int numCols, int nnz) |
template<typename Scalar > | |
mxArray * | createMatlabMultiVector (int numRows, int numCols) |
template<typename Scalar > | |
void | fillMatlabArray (Scalar *array, const mxArray *mxa, int n) |
std::vector< Teuchos::RCP < MuemexArg > > | callMatlab (std::string function, int numOutputs, std::vector< Teuchos::RCP< MuemexArg > > args) |
static std::string & | ltrim (std::string &s) |
static std::string & | rtrim (std::string &s) |
static std::string & | trim (std::string &s) |
template<> | |
MuemexType | getMuemexType (const int &data) |
template<> | |
MuemexType | getMuemexType< int > () |
template<> | |
MuemexType | getMuemexType< bool > () |
template<> | |
MuemexType | getMuemexType (const double &data) |
template<> | |
MuemexType | getMuemexType< double > () |
template<> | |
MuemexType | getMuemexType (const std::string &data) |
template<> | |
MuemexType | getMuemexType< string > () |
template<> | |
MuemexType | getMuemexType (const complex_t &data) |
template<> | |
MuemexType | getMuemexType< complex_t > () |
template<> | |
MuemexType | getMuemexType (const RCP< Xpetra_map > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Xpetra_map > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Xpetra_ordinal_vector > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Xpetra_ordinal_vector > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Tpetra_MultiVector_double > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Tpetra_MultiVector_double > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Tpetra_MultiVector_complex > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Tpetra_MultiVector_complex > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Tpetra_CrsMatrix_double > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Tpetra_CrsMatrix_double > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Tpetra_CrsMatrix_complex > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Tpetra_CrsMatrix_complex > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Xpetra_MultiVector_double > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Xpetra_MultiVector_double > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Xpetra_MultiVector_complex > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Xpetra_MultiVector_complex > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Xpetra_Matrix_double > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Xpetra_Matrix_double > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Xpetra_Matrix_complex > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Xpetra_Matrix_complex > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Epetra_CrsMatrix > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Epetra_CrsMatrix > > () |
template<> | |
MuemexType | getMuemexType (const RCP< Epetra_MultiVector > &data) |
template<> | |
MuemexType | getMuemexType< RCP< Epetra_MultiVector > > () |
template<> | |
MuemexType | getMuemexType (const RCP< MAggregates > &data) |
template<> | |
MuemexType | getMuemexType< RCP< MAggregates > > () |
template<> | |
MuemexType | getMuemexType (const RCP< MAmalInfo > &data) |
template<> | |
MuemexType | getMuemexType< RCP< MAmalInfo > > () |
template<> | |
MuemexType | getMuemexType (const RCP< MGraph > &data) |
template<> | |
MuemexType | getMuemexType< RCP< MGraph > > () |
template<> | |
RCP< Xpetra_map > | loadDataFromMatlab< RCP< Xpetra_map > > (const mxArray *mxa) |
template<> | |
RCP< Xpetra::Matrix< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > | loadDataFromMatlab< RCP< Xpetra::Matrix< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > (const mxArray *mxa) |
template<> | |
RCP< Xpetra::Matrix< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > | loadDataFromMatlab< RCP< Xpetra::Matrix< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > (const mxArray *mxa) |
template<> | |
RCP< Xpetra::MultiVector < double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > | loadDataFromMatlab< RCP< Xpetra::MultiVector< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > (const mxArray *mxa) |
template<> | |
RCP< Xpetra::MultiVector < complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > | loadDataFromMatlab< RCP< Xpetra::MultiVector< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > (const mxArray *mxa) |
template<> | |
RCP< MGraph > | loadDataFromMatlab< RCP< MGraph > > (const mxArray *mxa) |
template<> | |
mxArray * | saveDataToMatlab (RCP< Xpetra_map > &data) |
template<> | |
mxArray * | saveDataToMatlab (RCP< Tpetra::MultiVector< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > &data) |
template<> | |
mxArray * | saveDataToMatlab (RCP< Tpetra::MultiVector< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > &data) |
template<> | |
mxArray * | saveDataToMatlab (RCP< Xpetra::MultiVector< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > &data) |
template<> | |
mxArray * | saveDataToMatlab (RCP< Xpetra::MultiVector< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > &data) |
template<> | |
mxArray * | saveDataToMatlab (RCP< MGraph > &data) |
template<typename T > | |
void | addLevelVariable (const T &data, std::string &name, Level &lvl, const Factory *fact) |
template<> | |
std::vector< Teuchos::RCP < MuemexArg > > | processNeeds< double, mm_LocalOrd, long long, mm_node_t > (const Factory *factory, std::string &needsParam, Level &lvl) |
template<> | |
std::vector< Teuchos::RCP < MuemexArg > > | processNeeds< complex_t, mm_LocalOrd, long long, mm_node_t > (const Factory *factory, std::string &needsParam, Level &lvl) |
template<> | |
void | processProvides< double, mm_LocalOrd, long long, mm_node_t > (std::vector< Teuchos::RCP< MuemexArg > > &mexOutput, const Factory *factory, std::string &providesParam, Level &lvl) |
template<> | |
void | processProvides< complex_t, mm_LocalOrd, long long, mm_node_t > (std::vector< Teuchos::RCP< MuemexArg > > &mexOutput, const Factory *factory, std::string &providesParam, Level &lvl) |
Variables | |
std::map< std::string, std::string > | myParent_ |
bool | rewrap_ints = sizeof(int) != sizeof(mwIndex) |
Namespace for MueLu classes and methods.
typedef struct MueLu::MueLu_Node_Struct MueLu::MueLu_Node |
typedef Tpetra::Details::DefaultTypes::scalar_type MueLu::DefaultScalar |
Definition at line 20 of file MueLu_Details_DefaultTypes.hpp.
typedef int MueLu::DefaultLocalOrdinal |
Definition at line 22 of file MueLu_Details_DefaultTypes.hpp.
typedef int MueLu::DefaultGlobalOrdinal |
Definition at line 29 of file MueLu_Details_DefaultTypes.hpp.
typedef Tpetra::KokkosClassic::DefaultNode::DefaultNodeType MueLu::DefaultNode |
Definition at line 32 of file MueLu_Details_DefaultTypes.hpp.
typedef short MueLu::KeepType |
Definition at line 27 of file MueLu_KeepType.hpp.
typedef int MueLu::VerbLevel |
Definition at line 76 of file MueLu_VerbosityLevel.hpp.
typedef Tpetra::KokkosCompat::KokkosDeviceWrapperNode<Kokkos::Serial, Kokkos::HostSpace> MueLu::mm_node_t |
Definition at line 72 of file MueLu_MatlabUtils_decl.hpp.
typedef Tpetra::Map ::local_ordinal_type MueLu::mm_LocalOrd |
Definition at line 73 of file MueLu_MatlabUtils_decl.hpp.
typedef Tpetra::Map ::global_ordinal_type MueLu::mm_GlobalOrd |
Definition at line 74 of file MueLu_MatlabUtils_decl.hpp.
typedef std::complex<double> MueLu::complex_t |
Definition at line 75 of file MueLu_MatlabUtils_decl.hpp.
typedef Tpetra::Map MueLu::muemex_map_type |
Definition at line 76 of file MueLu_MatlabUtils_decl.hpp.
typedef Tpetra::CrsMatrix<double, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Tpetra_CrsMatrix_double |
Definition at line 77 of file MueLu_MatlabUtils_decl.hpp.
typedef Tpetra::CrsMatrix<complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Tpetra_CrsMatrix_complex |
Definition at line 78 of file MueLu_MatlabUtils_decl.hpp.
typedef Tpetra::MultiVector<double, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Tpetra_MultiVector_double |
Definition at line 79 of file MueLu_MatlabUtils_decl.hpp.
typedef Tpetra::MultiVector<complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Tpetra_MultiVector_complex |
Definition at line 80 of file MueLu_MatlabUtils_decl.hpp.
typedef Xpetra::Map<mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Xpetra_map |
Definition at line 81 of file MueLu_MatlabUtils_decl.hpp.
typedef Xpetra::Vector<mm_LocalOrd, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Xpetra_ordinal_vector |
Definition at line 82 of file MueLu_MatlabUtils_decl.hpp.
typedef Xpetra::Matrix<double, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Xpetra_Matrix_double |
Definition at line 83 of file MueLu_MatlabUtils_decl.hpp.
typedef Xpetra::Matrix<complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Xpetra_Matrix_complex |
Definition at line 84 of file MueLu_MatlabUtils_decl.hpp.
Definition at line 85 of file MueLu_MatlabUtils_decl.hpp.
typedef Xpetra::MultiVector<double, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Xpetra_MultiVector_double |
Definition at line 86 of file MueLu_MatlabUtils_decl.hpp.
typedef Xpetra::MultiVector<complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Xpetra_MultiVector_complex |
Definition at line 87 of file MueLu_MatlabUtils_decl.hpp.
typedef MueLu::Hierarchy<double, mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::Hierarchy_double |
Definition at line 88 of file MueLu_MatlabUtils_decl.hpp.
Definition at line 89 of file MueLu_MatlabUtils_decl.hpp.
Definition at line 90 of file MueLu_MatlabUtils_decl.hpp.
Definition at line 91 of file MueLu_MatlabUtils_decl.hpp.
typedef MueLu::LWGraph<mm_LocalOrd, mm_GlobalOrd, mm_node_t> MueLu::MGraph |
Definition at line 92 of file MueLu_MatlabUtils_decl.hpp.
Enumerator | |
---|---|
defaultAlgo | |
unscaled_cut | |
scaled_cut | |
scaled_cut_symmetric |
Definition at line 84 of file MueLu_CoalesceDropFactory_def.hpp.
enum MueLu::CycleType |
Enumerator | |
---|---|
VCYCLE | |
WCYCLE |
Definition at line 16 of file MueLu_Types.hpp.
enum MueLu::PreOrPost |
Enumerator | |
---|---|
PRE | |
POST | |
BOTH |
Definition at line 21 of file MueLu_Types.hpp.
enum MueLu::NodeState |
Enumerator | |
---|---|
READY | |
NOTSEL | |
AGGREGATED | |
ONEPT | |
IGNORED | |
BOUNDARY | |
INTERFACE |
Definition at line 28 of file MueLu_Types.hpp.
enum MueLu::IndexingType |
Enumerator | |
---|---|
UNCOUPLED | |
LOCALLEXI | |
GLOBALLEXI |
Definition at line 55 of file MueLu_Types.hpp.
|
strong |
Enumerator | |
---|---|
Converged | |
Unconverged | |
Undefined |
Definition at line 43 of file MueLu_Hierarchy_decl.hpp.
enum MueLu::KeepEnum |
Keep status of a variable of Level.
Enumerator | |
---|---|
UserData |
User data are always kept. This flag is set automatically when Level::Set("data", data) is used. The keep status of the variable is not propagated to coarser level (if you use Level::Build()). |
Keep |
Always keep data, even accross run. This flag is set by Level::Keep(). This flag is propagated to coarser level by Level::Build(). |
Final |
Keep data only for this run. Used to keep data useful for Hierarchy::Iterate(). Data will be deleted if setup phase is re-run. This flag is set by default for A, P, R, PreSmoother and PostSmoother of NoFactory by Hierarchy::Setup(). Not propagated by Level::Build(). |
NextRun |
Both UserData and Keep flags force data to be kept and reused for the next run. Do not use MueLu::NextRun in AddKeepFlag. Use it only for testing keep == UserData || keep == Keep. |
All |
Definition at line 17 of file MueLu_KeepType.hpp.
enum MueLu::MsgType |
Enumerator | |
---|---|
Errors |
Errors. |
Warnings0 |
Important warning messages (one line) |
Warnings00 |
Important warning messages (more verbose) |
Warnings1 |
Additional warnings. |
PerfWarnings |
Performance warnings. |
Runtime0 |
One-liner description of what is happening. |
Runtime1 |
Description of what is happening (more verbose) |
RuntimeTimings |
Timers that are enabled (using Timings0/Timings1) will be printed during the execution. |
NoTimeReport |
By default, enabled timers appears in the teuchos time monitor summary. Use this option if you do not want to record timing information. |
Parameters0 |
Print class parameters. |
Parameters1 |
Print class parameters (more parameters, more verbose) |
Statistics0 |
Print statistics that do not involve significant additional computation. |
Statistics1 |
Print more statistics. |
Statistics2 |
Print even more statistics. |
Timings0 |
High level timing information (use Teuchos::TimeMonitor::summarize() to print) |
Timings1 |
Detailed timing information (use Teuchos::TimeMonitor::summarize() to print) |
TimingsByLevel |
Record timing information level by level. Must be used in combinaison with Timings0/Timings1. |
External |
Print external lib objects. |
Debug |
Print additional debugging information. |
Developer |
Print information primarily of interest to developers. |
Test0 |
Print factory calls. |
Test1 |
Print used parameters. |
Warnings |
Print all warning messages. |
Runtime |
Print description of what is going on. |
Parameters |
Print parameters. |
Statistics |
Print all statistics. |
Timings |
Print all timing information. |
Test | |
InterfaceTest | |
None | |
Low | |
Medium | |
High | |
Extreme | |
Default | |
NotSpecified |
Definition at line 17 of file MueLu_VerbosityLevel.hpp.
Enumerator | |
---|---|
ANORM | |
L2NORM | |
DINVANORM |
Definition at line 30 of file MueLu_PgPFactory_decl.hpp.
enum MueLu::MuemexType |
Definition at line 45 of file MueLu_MatlabUtils_decl.hpp.
|
inline |
Definition at line 19 of file MueLu_Version.hpp.
|
static |
Definition at line 512 of file MueLu_ML2MueLuParameterTranslator.cpp.
|
static |
Definition at line 528 of file MueLu_ML2MueLuParameterTranslator.cpp.
void MueLu::CreateSublists | ( | const ParameterList & | List, |
ParameterList & | newList | ||
) |
Definition at line 27 of file MueLu_ParameterListUtils.cpp.
size_t MueLu::LevenshteinDistance | ( | const char * | s, |
size_t | len_s, | ||
const char * | t, | ||
size_t | len_t | ||
) |
Definition at line 17 of file MueLu_ParameterListInterpreter.cpp.
|
inlinestatic |
Helper functions to compare two paramter lists.
Definition at line 2661 of file MueLu_ParameterListInterpreter_def.hpp.
|
static |
Definition at line 2640 of file MueLu_ParameterListInterpreter_def.hpp.
void MueLu::MergeParameterList | ( | const Teuchos::ParameterList & | source, |
Teuchos::ParameterList & | dest, | ||
bool | overWrite | ||
) |
: merge two parameter lists
source | [in]: parameter lists with source parameters which are to be merged in into the dest parameter list |
dest | [in,out]: parameter list with, e.g., default parameters which is extended by parameters from source parameter list |
overWrite | (bool): if true, overwrite parameters in dest with entries from source |
Definition at line 21 of file MueLu_ParameterListUtils.cpp.
const Teuchos::ParameterList & MueLu::GetMLSubList | ( | const Teuchos::ParameterList & | paramList, |
const std::string & | type, | ||
int | levelID | ||
) |
Definition at line 104 of file MueLu_ParameterListUtils.cpp.
Teuchos::RCP< Teuchos::ParameterList > MueLu::ExtractSetOfParameters | ( | const Teuchos::ParameterList & | paramList, |
const std::string & | str | ||
) |
Definition at line 119 of file MueLu_ParameterListUtils.cpp.
void MueLu::replaceAll | ( | std::string & | str, |
const std::string & | from, | ||
const std::string & | to | ||
) |
replace all string occurrences "from" with "to" in "str"
str,: | input and output string |
from,: | search string |
to,: | replace with "to" |
Definition at line 134 of file MueLu_ParameterListUtils.cpp.
bool MueLu::replacePlaceholder | ( | std::string & | str, |
const std::string & | placeholder, | ||
Type | data | ||
) |
templated version to replace placeholder by data in "str"
Definition at line 42 of file MueLu_ParameterListUtils.hpp.
bool MueLu::actionInterpretParameter | ( | Teuchos::ParameterList & | mlParams, |
const std::string & | paramName, | ||
std::string & | str | ||
) |
Definition at line 50 of file MueLu_ParameterListUtils.hpp.
void MueLu::sort_and_unique | ( | T & | array | ) |
Definition at line 32 of file MueLu_FilteredAFactory_def.hpp.
void MueLu::printParameterListOptions | ( | std::ostream & | os, |
const Teuchos::ParameterList & | p | ||
) |
Definition at line 18 of file MueLu_ParameterListAcceptor.cpp.
VerbLevel MueLu::toMueLuVerbLevel | ( | const Teuchos::EVerbosityLevel | verbLevel | ) |
Translate Teuchos verbosity level to MueLu verbosity level.
Definition at line 18 of file MueLu_VerbosityLevel.cpp.
std::string MueLu::lowerCase | ( | const std::string & | s | ) |
Definition at line 38 of file MueLu_VerbosityLevel.cpp.
MsgType MueLu::toVerbLevel | ( | const std::string & | verbLevelStr | ) |
Definition at line 52 of file MueLu_VerbosityLevel.cpp.
T MueLu::pop | ( | Teuchos::ParameterList & | pl, |
std::string const & | name_in | ||
) |
Definition at line 68 of file MueLu_RefMaxwell_def.hpp.
T MueLu::pop | ( | Teuchos::ParameterList & | pl, |
std::string const & | name_in, | ||
T | def_value | ||
) |
Definition at line 75 of file MueLu_RefMaxwell_def.hpp.
Teuchos::RCP<Xpetra::CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> > MueLu::Matrix2CrsMatrix | ( | Teuchos::RCP< Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | matrix | ) |
Definition at line 83 of file MueLu_RefMaxwell_def.hpp.
|
static |
Definition at line 420 of file MueLu_RepartitionFactory_def.hpp.
RCP<MueLu::SmootherPrototype<Scalar, LocalOrdinal, GlobalOrdinal, Node> > MueLu::GetAmesosSmoother | ( | const std::string & | = "" , |
const Teuchos::ParameterList & | = Teuchos::ParameterList() |
||
) |
Non-member templated function GetAmesosSmoother() returns a new AmesosSmoother object.
This function simplifies the usage of AmesosSmoother objects inside of templates as templates do not have to be specialized for <double, int, int> (see DirectSolver for an example).
Definition at line 158 of file MueLu_AmesosSmoother.hpp.
RCP<MueLu::SmootherPrototype<Scalar, LocalOrdinal, GlobalOrdinal, Node> > MueLu::GetIfpackSmoother | ( | const std::string & | = "" , |
const Teuchos::ParameterList & | = Teuchos::ParameterList() , |
||
const LocalOrdinal & | = 0 |
||
) |
Non-member templated function GetIfpackSmoother() returns a new IfpackSmoother object when <Scalar, LocalOrdinal, GlobalOrdinal> == <double, int, int>. Otherwise, an exception is thrown. This function simplifies the usage of IfpackSmoother objects inside of templates as templates do not have to be specialized for <double, int, int> (see DirectSolver for an example).
Definition at line 172 of file MueLu_IfpackSmoother.hpp.
|
inline |
Definition at line 183 of file MueLu_IfpackSmoother.hpp.
CompPairs<Scalar, LocalOrdinal> MueLu::CreateCmpPairs | ( | const std::vector< Scalar > & | v | ) |
Definition at line 48 of file MueLu_AlgebraicPermutationStrategy_decl.hpp.
void MueLu::sortingPermutation | ( | const std::vector< Scalar > & | values, |
std::vector< LocalOrdinal > & | v | ||
) |
Definition at line 54 of file MueLu_AlgebraicPermutationStrategy_decl.hpp.
void MueLu::calculateStats | ( | Type & | minVal, |
Type & | maxVal, | ||
double & | avgVal, | ||
double & | devVal, | ||
int & | minProc, | ||
int & | maxProc, | ||
const RCP< const Teuchos::Comm< int > > & | comm, | ||
int | numActiveProcs, | ||
const Type & | v | ||
) |
Definition at line 32 of file MueLu_PerfUtils_def.hpp.
std::string MueLu::stringStats | ( | const RCP< const Teuchos::Comm< int > > & | comm, |
int | numActiveProcs, | ||
const Type & | v, | ||
RCP< ParameterList > | paramList = Teuchos::null |
||
) |
Definition at line 54 of file MueLu_PerfUtils_def.hpp.
bool MueLu::cmp_less | ( | typename Map::value_type & | v1, |
typename Map::value_type & | v2 | ||
) |
Definition at line 87 of file MueLu_PerfUtils_def.hpp.
long MueLu::ExtractNonSerializableData | ( | const Teuchos::ParameterList & | inList, |
Teuchos::ParameterList & | serialList, | ||
Teuchos::ParameterList & | nonSerialList | ||
) |
Extract non-serializable data from level-specific sublists and move it to a separate parameter list.
Look through the level-specific sublists form inList
, extract non-serializable data and move it to nonSerialList
. Everything else is copied to the serialList
.
Non-serializable data to be moved:
[in] | inList | List with all input parameters/data as provided by the user |
[out] | serialList | All serializable data from the input list |
[out] | nonSerialList | All non-serializable, i.e. rank-specific data from the input list |
Definition at line 31 of file MueLu_Utilities.cpp.
void MueLu::TokenizeStringAndStripWhiteSpace | ( | const std::string & | stream, |
std::vector< std::string > & | tokenList, | ||
const char * | token = "," |
||
) |
Tokenizes a (comma)-separated string, removing all leading and trailing whitespace
WARNING: This routine is not threadsafe on most architectures
Definition at line 81 of file MueLu_Utilities.cpp.
bool MueLu::IsParamMuemexVariable | ( | const std::string & | name | ) |
Returns true if a parameter name is a valid Muemex custom level variable, e.g. "MultiVector myArray"
Definition at line 110 of file MueLu_Utilities.cpp.
bool MueLu::IsParamValidVariable | ( | const std::string & | name | ) |
Returns true if a parameter name is a valid user custom level variable, e.g. "MultiVector myArray"
Definition at line 156 of file MueLu_Utilities.cpp.
Teuchos::RCP<const Teuchos::Comm<int> > MueLu::GenerateNodeComm | ( | RCP< const Teuchos::Comm< int > > & | baseComm, |
int & | NodeId, | ||
const int | reductionFactor | ||
) |
Definition at line 207 of file MueLu_Utilities.cpp.
RCP< Xpetra::CrsMatrixWrap< SC, LO, GO, NO > > MueLu::Convert_Epetra_CrsMatrix_ToXpetra_CrsMatrixWrap | ( | RCP< Epetra_CrsMatrix > & | epAB | ) |
Definition at line 80 of file MueLu_Utilities_def.hpp.
RCP<Xpetra::Matrix<SC, LO, GO, NO> > MueLu::EpetraCrs_To_XpetraMatrix | ( | const Teuchos::RCP< Epetra_CrsMatrix > & | A | ) |
Definition at line 918 of file MueLu_Utilities_decl.hpp.
RCP<Xpetra::MultiVector<SC, LO, GO, NO> > MueLu::EpetraMultiVector_To_XpetraMultiVector | ( | const Teuchos::RCP< Epetra_MultiVector > & | V | ) |
Definition at line 933 of file MueLu_Utilities_decl.hpp.
RCP<Xpetra::Matrix<SC, LO, GO, NO> > MueLu::TpetraCrs_To_XpetraMatrix | ( | const Teuchos::RCP< Tpetra::CrsMatrix< SC, LO, GO, NO >> & | Atpetra | ) |
Definition at line 944 of file MueLu_Utilities_decl.hpp.
RCP<Xpetra::Matrix<SC, LO, GO, NO> > MueLu::TpetraFECrs_To_XpetraMatrix | ( | const Teuchos::RCP< Tpetra::FECrsMatrix< SC, LO, GO, NO >> & | Atpetra | ) |
Definition at line 1068 of file MueLu_Utilities_decl.hpp.
RCP<Xpetra::MultiVector<SC, LO, GO, NO> > MueLu::TpetraMultiVector_To_XpetraMultiVector | ( | const Teuchos::RCP< Tpetra::MultiVector< SC, LO, GO, NO >> & | Vtpetra | ) |
Definition at line 1084 of file MueLu_Utilities_decl.hpp.
RCP<Xpetra::MultiVector<SC, LO, GO, NO> > MueLu::TpetraFEMultiVector_To_XpetraMultiVector | ( | const Teuchos::RCP< Tpetra::FEMultiVector< SC, LO, GO, NO >> & | Vtpetra | ) |
Definition at line 1094 of file MueLu_Utilities_decl.hpp.
void MueLu::leftRghtDofScalingWithinNode | ( | const Xpetra::Matrix< SC, LO, GO, NO > & | Atpetra, |
size_t | blkSize, | ||
size_t | nSweeps, | ||
Teuchos::ArrayRCP< SC > & | rowScaling, | ||
Teuchos::ArrayRCP< SC > & | colScaling | ||
) |
Definition at line 981 of file MueLu_Utilities_decl.hpp.
Teuchos::RCP< const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > MueLu::importOffRankDroppingInfo | ( | Teuchos::RCP< const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node >> & | localDropMap, |
Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> & | Ain | ||
) |
Definition at line 1149 of file MueLu_Utilities_decl.hpp.
RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > MueLu::EpetraCrs_To_XpetraMatrix | ( | const Teuchos::RCP< Epetra_CrsMatrix > & | A | ) |
Definition at line 918 of file MueLu_Utilities_decl.hpp.
RCP< Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > MueLu::EpetraMultiVector_To_XpetraMultiVector | ( | const Teuchos::RCP< Epetra_MultiVector > & | V | ) |
Definition at line 933 of file MueLu_Utilities_decl.hpp.
RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > MueLu::TpetraCrs_To_XpetraMatrix | ( | const Teuchos::RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> & | Atpetra | ) |
Definition at line 944 of file MueLu_Utilities_decl.hpp.
RCP<Xpetra::Matrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> > MueLu::TpetraFECrs_To_XpetraMatrix | ( | const Teuchos::RCP< Tpetra::FECrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> & | Atpetra | ) |
Definition at line 1068 of file MueLu_Utilities_decl.hpp.
RCP< Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > MueLu::TpetraMultiVector_To_XpetraMultiVector | ( | const Teuchos::RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >> & | Vtpetra | ) |
Definition at line 1084 of file MueLu_Utilities_decl.hpp.
RCP<Xpetra::MultiVector<Scalar, LocalOrdinal, GlobalOrdinal, Node> > MueLu::TpetraFEMultiVector_To_XpetraMultiVector | ( | const Teuchos::RCP< Tpetra::FEMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >> & | Vtpetra | ) |
Definition at line 1094 of file MueLu_Utilities_decl.hpp.
std::string MueLu::toString | ( | const T & | what | ) |
Little helper function to convert non-string types to strings.
Definition at line 1102 of file MueLu_Utilities_decl.hpp.
Teuchos::RCP<const Teuchos::Comm<int> > MueLu::GenerateNodeComm | ( | RCP< const Teuchos::Comm< int >> & | baseComm, |
int & | NodeId, | ||
const int | reductionFactor | ||
) |
Teuchos::RCP<Xpetra::Matrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> > MueLu::removeSmallEntries | ( | Teuchos::RCP< Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >> & | A, |
const typename Teuchos::ScalarTraits< Scalar >::magnitudeType | threshold, | ||
const bool | keepDiagonal | ||
) |
Definition at line 56 of file MueLu_UtilitiesBase_def.hpp.
Kokkos::View<bool*, memory_space> MueLu::DetectDirichletRows_kokkos | ( | const Xpetra::Matrix< SC, LO, GO, NO > & | A, |
const typename Teuchos::ScalarTraits< SC >::magnitudeType & | tol, | ||
const bool | count_twos_as_dirichlet | ||
) |
Definition at line 1029 of file MueLu_UtilitiesBase_def.hpp.
void MueLu::ApplyRowSumCriterion | ( | const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | A, |
const typename Teuchos::ScalarTraits< Scalar >::magnitudeType | rowSumTol, | ||
Kokkos::View< bool *, memory_space > & | dirichletRows | ||
) |
Definition at line 1365 of file MueLu_UtilitiesBase_def.hpp.
void MueLu::ApplyRowSumCriterion | ( | const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | A, |
const Xpetra::Vector< LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > & | BlockNumber, | ||
const typename Teuchos::ScalarTraits< Scalar >::magnitudeType | rowSumTol, | ||
Kokkos::View< bool *, memory_space > & | dirichletRows | ||
) |
Definition at line 1413 of file MueLu_UtilitiesBase_def.hpp.
void MueLu::MueLu_AMGX_initialize | ( | ) |
Definition at line 15 of file MueLu_AMGX_Setup.cpp.
void MueLu::MueLu_AMGX_initialize_plugins | ( | ) |
Definition at line 19 of file MueLu_AMGX_Setup.cpp.
void MueLu::MueLu_AMGX_finalize | ( | ) |
Definition at line 23 of file MueLu_AMGX_Setup.cpp.
void MueLu::MueLu_AMGX_finalize_plugins | ( | ) |
Definition at line 27 of file MueLu_AMGX_Setup.cpp.
void MueLu::ReuseEpetraPreconditioner | ( | const Teuchos::RCP< Epetra_CrsMatrix > & | inA, |
MueLu::EpetraOperator & | Op | ||
) |
Definition at line 114 of file MueLu_CreateEpetraPreconditioner.cpp.
void MueLu::ReuseTpetraPreconditioner | ( | const Teuchos::RCP< Tpetra::BlockCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | inA, |
MueLu::TpetraOperator< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | Op | ||
) |
Definition at line 174 of file MueLu_CreateTpetraPreconditioner.hpp.
int * MueLu::mwIndex_to_int | ( | int | N, |
mwIndex * | mwi_array | ||
) |
Definition at line 49 of file MueLu_MatlabUtils.cpp.
mxArray * MueLu::createMatlabSparse< double > | ( | int | numRows, |
int | numCols, | ||
int | nnz | ||
) |
Definition at line 62 of file MueLu_MatlabUtils.cpp.
mxArray * MueLu::createMatlabSparse< complex_t > | ( | int | numRows, |
int | numCols, | ||
int | nnz | ||
) |
Definition at line 67 of file MueLu_MatlabUtils.cpp.
void MueLu::fillMatlabArray< double > | ( | double * | array, |
const mxArray * | mxa, | ||
int | n | ||
) |
Definition at line 72 of file MueLu_MatlabUtils.cpp.
void MueLu::fillMatlabArray< complex_t > | ( | complex_t * | array, |
const mxArray * | mxa, | ||
int | n | ||
) |
Definition at line 77 of file MueLu_MatlabUtils.cpp.
void MueLu::callMatlabNoArgs | ( | std::string | function | ) |
Definition at line 90 of file MueLu_MatlabUtils.cpp.
std::vector<RCP<MuemexArg> > MueLu::callMatlab | ( | std::string | function, |
int | numOutputs, | ||
std::vector< RCP< MuemexArg > > | args | ||
) |
Definition at line 96 of file MueLu_MatlabUtils.cpp.
mxArray * MueLu::createMatlabMultiVector< double > | ( | int | numRows, |
int | numCols | ||
) |
Definition at line 200 of file MueLu_MatlabUtils.cpp.
mxArray * MueLu::createMatlabMultiVector< complex_t > | ( | int | numRows, |
int | numCols | ||
) |
Definition at line 205 of file MueLu_MatlabUtils.cpp.
mxArray* MueLu::saveAmalInfo | ( | RCP< MAmalInfo > & | amalInfo | ) |
Definition at line 209 of file MueLu_MatlabUtils.cpp.
bool MueLu::isValidMatlabAggregates | ( | const mxArray * | mxa | ) |
Definition at line 214 of file MueLu_MatlabUtils.cpp.
bool MueLu::isValidMatlabGraph | ( | const mxArray * | mxa | ) |
Definition at line 241 of file MueLu_MatlabUtils.cpp.
std::vector< std::string > MueLu::tokenizeList | ( | const std::string & | params | ) |
Definition at line 259 of file MueLu_MatlabUtils.cpp.
Teuchos::RCP< Teuchos::ParameterList > MueLu::getInputParamList | ( | ) |
Definition at line 283 of file MueLu_MatlabUtils.cpp.
Teuchos::RCP< MuemexArg > MueLu::convertMatlabVar | ( | const mxArray * | mxa | ) |
Definition at line 300 of file MueLu_MatlabUtils.cpp.
bool MueLu::loadDataFromMatlab< bool > | ( | const mxArray * | mxa | ) |
Definition at line 185 of file MueLu_MatlabUtils_def.hpp.
int MueLu::loadDataFromMatlab< int > | ( | const mxArray * | mxa | ) |
Definition at line 166 of file MueLu_MatlabUtils_def.hpp.
double MueLu::loadDataFromMatlab< double > | ( | const mxArray * | mxa | ) |
Definition at line 190 of file MueLu_MatlabUtils_def.hpp.
complex_t MueLu::loadDataFromMatlab< complex_t > | ( | const mxArray * | mxa | ) |
Definition at line 195 of file MueLu_MatlabUtils_def.hpp.
string MueLu::loadDataFromMatlab< string > | ( | const mxArray * | mxa | ) |
Definition at line 202 of file MueLu_MatlabUtils_def.hpp.
RCP< Xpetra_ordinal_vector > MueLu::loadDataFromMatlab< RCP< Xpetra_ordinal_vector > > | ( | const mxArray * | mxa | ) |
Definition at line 240 of file MueLu_MatlabUtils_def.hpp.
RCP< Tpetra_MultiVector_double > MueLu::loadDataFromMatlab< RCP< Tpetra_MultiVector_double > > | ( | const mxArray * | mxa | ) |
Definition at line 261 of file MueLu_MatlabUtils_def.hpp.
RCP< Tpetra_MultiVector_complex > MueLu::loadDataFromMatlab< RCP< Tpetra_MultiVector_complex > > | ( | const mxArray * | mxa | ) |
Definition at line 281 of file MueLu_MatlabUtils_def.hpp.
RCP< Tpetra_CrsMatrix_double > MueLu::loadDataFromMatlab< RCP< Tpetra_CrsMatrix_double > > | ( | const mxArray * | mxa | ) |
Definition at line 308 of file MueLu_MatlabUtils_def.hpp.
RCP< Tpetra_CrsMatrix_complex > MueLu::loadDataFromMatlab< RCP< Tpetra_CrsMatrix_complex > > | ( | const mxArray * | mxa | ) |
Definition at line 372 of file MueLu_MatlabUtils_def.hpp.
template RCP<Xpetra_Matrix_double> MueLu::loadDataFromMatlab< RCP< Xpetra_Matrix_double > > | ( | const mxArray * | mxa | ) |
template RCP<Xpetra_Matrix_complex> MueLu::loadDataFromMatlab< RCP< Xpetra_Matrix_complex > > | ( | const mxArray * | mxa | ) |
template RCP<Xpetra_MultiVector_double> MueLu::loadDataFromMatlab< RCP< Xpetra_MultiVector_double > > | ( | const mxArray * | mxa | ) |
template RCP<Xpetra_MultiVector_complex> MueLu::loadDataFromMatlab< RCP< Xpetra_MultiVector_complex > > | ( | const mxArray * | mxa | ) |
RCP< Epetra_CrsMatrix > MueLu::loadDataFromMatlab< RCP< Epetra_CrsMatrix > > | ( | const mxArray * | mxa | ) |
Definition at line 449 of file MueLu_MatlabUtils_def.hpp.
RCP< Epetra_MultiVector > MueLu::loadDataFromMatlab< RCP< Epetra_MultiVector > > | ( | const mxArray * | mxa | ) |
Definition at line 488 of file MueLu_MatlabUtils_def.hpp.
RCP< MAggregates > MueLu::loadDataFromMatlab< RCP< MAggregates > > | ( | const mxArray * | mxa | ) |
Definition at line 497 of file MueLu_MatlabUtils_def.hpp.
RCP< MAmalInfo > MueLu::loadDataFromMatlab< RCP< MAmalInfo > > | ( | const mxArray * | mxa | ) |
Definition at line 545 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | bool & | data | ) |
Definition at line 657 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | int & | data | ) |
Definition at line 649 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | double & | data | ) |
Definition at line 665 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | complex_t & | data | ) |
Definition at line 670 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | string & | data | ) |
Definition at line 679 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< Xpetra_ordinal_vector > & | data | ) |
Definition at line 700 of file MueLu_MatlabUtils_def.hpp.
template mxArray* MueLu::saveDataToMatlab | ( | RCP< Tpetra_MultiVector_double > & | data | ) |
template mxArray* MueLu::saveDataToMatlab | ( | RCP< Tpetra_MultiVector_complex > & | data | ) |
mxArray * MueLu::saveDataToMatlab | ( | RCP< Tpetra_CrsMatrix_double > & | data | ) |
Definition at line 726 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< Tpetra_CrsMatrix_complex > & | data | ) |
Definition at line 732 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< Xpetra_Matrix_double > & | data | ) |
Definition at line 738 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< Xpetra_Matrix_complex > & | data | ) |
Definition at line 846 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< Xpetra_MultiVector_double > & | data | ) |
mxArray * MueLu::saveDataToMatlab | ( | RCP< Xpetra_MultiVector_complex > & | data | ) |
mxArray * MueLu::saveDataToMatlab | ( | RCP< Epetra_CrsMatrix > & | data | ) |
Definition at line 1009 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< Epetra_MultiVector > & | data | ) |
Definition at line 1015 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< MAggregates > & | data | ) |
Definition at line 1023 of file MueLu_MatlabUtils_def.hpp.
mxArray * MueLu::saveDataToMatlab | ( | RCP< MAmalInfo > & | data | ) |
Definition at line 1100 of file MueLu_MatlabUtils_def.hpp.
template vector<RCP<MuemexArg> > MueLu::processNeeds< double > | ( | const Factory * | factory, |
string & | needsParam, | ||
Level & | lvl | ||
) |
template vector<RCP<MuemexArg> > MueLu::processNeeds< complex_t > | ( | const Factory * | factory, |
string & | needsParam, | ||
Level & | lvl | ||
) |
template void MueLu::processProvides< double > | ( | vector< RCP< MuemexArg > > & | mexOutput, |
const Factory * | factory, | ||
string & | providesParam, | ||
Level & | lvl | ||
) |
template void MueLu::processProvides< complex_t > | ( | vector< RCP< MuemexArg > > & | mexOutput, |
const Factory * | factory, | ||
string & | providesParam, | ||
Level & | lvl | ||
) |
MuemexType MueLu::getMuemexType | ( | const T & | data | ) |
Definition at line 32 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | ) |
T MueLu::loadDataFromMatlab | ( | const mxArray * | mxa | ) |
mxArray* MueLu::saveDataToMatlab | ( | T & | data | ) |
void MueLu::addLevelVariable | ( | const T & | data, |
std::string & | name, | ||
Level & | lvl, | ||
const FactoryBase * | fact = NoFactory::get() |
||
) |
const T & MueLu::getLevelVariable | ( | std::string & | name, |
Level & | lvl | ||
) |
Definition at line 1258 of file MueLu_MatlabUtils_def.hpp.
std::vector< Teuchos::RCP< MuemexArg > > MueLu::processNeeds | ( | const Factory * | factory, |
std::string & | needsParam, | ||
Level & | lvl | ||
) |
Definition at line 1268 of file MueLu_MatlabUtils_def.hpp.
void MueLu::processProvides | ( | std::vector< Teuchos::RCP< MuemexArg > > & | mexOutput, |
const Factory * | factory, | ||
std::string & | providesParam, | ||
Level & | lvl | ||
) |
Definition at line 1362 of file MueLu_MatlabUtils_def.hpp.
mxArray* MueLu::createMatlabSparse | ( | int | numRows, |
int | numCols, | ||
int | nnz | ||
) |
mxArray* MueLu::createMatlabMultiVector | ( | int | numRows, |
int | numCols | ||
) |
void MueLu::fillMatlabArray | ( | Scalar * | array, |
const mxArray * | mxa, | ||
int | n | ||
) |
std::vector<Teuchos::RCP<MuemexArg> > MueLu::callMatlab | ( | std::string | function, |
int | numOutputs, | ||
std::vector< Teuchos::RCP< MuemexArg > > | args | ||
) |
|
inlinestatic |
Definition at line 165 of file MueLu_MatlabUtils_decl.hpp.
|
inlinestatic |
Definition at line 171 of file MueLu_MatlabUtils_decl.hpp.
|
inlinestatic |
Definition at line 177 of file MueLu_MatlabUtils_decl.hpp.
MuemexType MueLu::getMuemexType | ( | const int & | data | ) |
Definition at line 35 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< int > | ( | ) |
Definition at line 37 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< bool > | ( | ) |
Definition at line 39 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const double & | data | ) |
Definition at line 42 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< double > | ( | ) |
Definition at line 44 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const std::string & | data | ) |
Definition at line 47 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< string > | ( | ) |
Definition at line 49 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const complex_t & | data | ) |
Definition at line 52 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< complex_t > | ( | ) |
Definition at line 54 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Xpetra_map > & | data | ) |
Definition at line 57 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Xpetra_map > > | ( | ) |
Definition at line 59 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Xpetra_ordinal_vector > & | data | ) |
Definition at line 62 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Xpetra_ordinal_vector > > | ( | ) |
Definition at line 64 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Tpetra_MultiVector_double > & | data | ) |
Definition at line 67 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Tpetra_MultiVector_double > > | ( | ) |
Definition at line 69 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Tpetra_MultiVector_complex > & | data | ) |
Definition at line 72 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Tpetra_MultiVector_complex > > | ( | ) |
Definition at line 74 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Tpetra_CrsMatrix_double > & | data | ) |
Definition at line 77 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Tpetra_CrsMatrix_double > > | ( | ) |
Definition at line 79 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Tpetra_CrsMatrix_complex > & | data | ) |
Definition at line 82 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Tpetra_CrsMatrix_complex > > | ( | ) |
Definition at line 84 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Xpetra_MultiVector_double > & | data | ) |
Definition at line 87 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Xpetra_MultiVector_double > > | ( | ) |
Definition at line 89 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Xpetra_MultiVector_complex > & | data | ) |
Definition at line 92 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Xpetra_MultiVector_complex > > | ( | ) |
Definition at line 94 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Xpetra_Matrix_double > & | data | ) |
Definition at line 97 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Xpetra_Matrix_double > > | ( | ) |
Definition at line 99 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Xpetra_Matrix_complex > & | data | ) |
Definition at line 102 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Xpetra_Matrix_complex > > | ( | ) |
Definition at line 104 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Epetra_CrsMatrix > & | data | ) |
Definition at line 107 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Epetra_CrsMatrix > > | ( | ) |
Definition at line 109 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< Epetra_MultiVector > & | data | ) |
Definition at line 112 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< Epetra_MultiVector > > | ( | ) |
Definition at line 114 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< MAggregates > & | data | ) |
Definition at line 117 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< MAggregates > > | ( | ) |
Definition at line 119 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< MAmalInfo > & | data | ) |
Definition at line 122 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< MAmalInfo > > | ( | ) |
Definition at line 124 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType | ( | const RCP< MGraph > & | data | ) |
Definition at line 127 of file MueLu_MatlabUtils_def.hpp.
MuemexType MueLu::getMuemexType< RCP< MGraph > > | ( | ) |
Definition at line 129 of file MueLu_MatlabUtils_def.hpp.
RCP<Xpetra_map> MueLu::loadDataFromMatlab< RCP< Xpetra_map > > | ( | const mxArray * | mxa | ) |
Definition at line 212 of file MueLu_MatlabUtils_def.hpp.
RCP<Xpetra::Matrix<double, mm_LocalOrd, mm_GlobalOrd, mm_node_t> > MueLu::loadDataFromMatlab< RCP< Xpetra::Matrix< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > | ( | const mxArray * | mxa | ) |
Definition at line 425 of file MueLu_MatlabUtils_def.hpp.
RCP<Xpetra::Matrix<complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t> > MueLu::loadDataFromMatlab< RCP< Xpetra::Matrix< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > | ( | const mxArray * | mxa | ) |
Definition at line 431 of file MueLu_MatlabUtils_def.hpp.
RCP<Xpetra::MultiVector<double, mm_LocalOrd, mm_GlobalOrd, mm_node_t> > MueLu::loadDataFromMatlab< RCP< Xpetra::MultiVector< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > | ( | const mxArray * | mxa | ) |
Definition at line 437 of file MueLu_MatlabUtils_def.hpp.
RCP<Xpetra::MultiVector<complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t> > MueLu::loadDataFromMatlab< RCP< Xpetra::MultiVector< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > > | ( | const mxArray * | mxa | ) |
Definition at line 443 of file MueLu_MatlabUtils_def.hpp.
RCP<MGraph> MueLu::loadDataFromMatlab< RCP< MGraph > > | ( | const mxArray * | mxa | ) |
Definition at line 552 of file MueLu_MatlabUtils_def.hpp.
mxArray* MueLu::saveDataToMatlab | ( | RCP< Xpetra_map > & | data | ) |
Definition at line 684 of file MueLu_MatlabUtils_def.hpp.
mxArray* MueLu::saveDataToMatlab | ( | RCP< Tpetra::MultiVector< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > & | data | ) |
Definition at line 714 of file MueLu_MatlabUtils_def.hpp.
mxArray* MueLu::saveDataToMatlab | ( | RCP< Tpetra::MultiVector< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > & | data | ) |
Definition at line 720 of file MueLu_MatlabUtils_def.hpp.
mxArray* MueLu::saveDataToMatlab | ( | RCP< Xpetra::MultiVector< double, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > & | data | ) |
Definition at line 973 of file MueLu_MatlabUtils_def.hpp.
mxArray* MueLu::saveDataToMatlab | ( | RCP< Xpetra::MultiVector< complex_t, mm_LocalOrd, mm_GlobalOrd, mm_node_t > > & | data | ) |
Definition at line 991 of file MueLu_MatlabUtils_def.hpp.
mxArray* MueLu::saveDataToMatlab | ( | RCP< MGraph > & | data | ) |
Definition at line 1106 of file MueLu_MatlabUtils_def.hpp.
void MueLu::addLevelVariable | ( | const T & | data, |
std::string & | name, | ||
Level & | lvl, | ||
const Factory * | fact | ||
) |
Definition at line 1252 of file MueLu_MatlabUtils_def.hpp.
std::vector<Teuchos::RCP<MuemexArg> > MueLu::processNeeds< double, mm_LocalOrd, long long, mm_node_t > | ( | const Factory * | factory, |
std::string & | needsParam, | ||
Level & | lvl | ||
) |
Definition at line 1456 of file MueLu_MatlabUtils_def.hpp.
std::vector<Teuchos::RCP<MuemexArg> > MueLu::processNeeds< complex_t, mm_LocalOrd, long long, mm_node_t > | ( | const Factory * | factory, |
std::string & | needsParam, | ||
Level & | lvl | ||
) |
Definition at line 1461 of file MueLu_MatlabUtils_def.hpp.
void MueLu::processProvides< double, mm_LocalOrd, long long, mm_node_t > | ( | std::vector< Teuchos::RCP< MuemexArg > > & | mexOutput, |
const Factory * | factory, | ||
std::string & | providesParam, | ||
Level & | lvl | ||
) |
Definition at line 1466 of file MueLu_MatlabUtils_def.hpp.
void MueLu::processProvides< complex_t, mm_LocalOrd, long long, mm_node_t > | ( | std::vector< Teuchos::RCP< MuemexArg > > & | mexOutput, |
const Factory * | factory, | ||
std::string & | providesParam, | ||
Level & | lvl | ||
) |
Definition at line 1471 of file MueLu_MatlabUtils_def.hpp.
std::map<std::string, std::string> MueLu::myParent_ |
Definition at line 28 of file MueLu_MutuallyExclusiveTime.cpp.
bool MueLu::rewrap_ints = sizeof(int) != sizeof(mwIndex) |
Definition at line 47 of file MueLu_MatlabUtils.cpp.