apf | |
GeometricGen | |
DOTS | |
CoordinatePoint | |
Hole | |
SquareHole | |
RectangleHole | |
CircleHole | |
CubeHole | |
RectangularPrismHole | |
SphereHole | |
WeightDistribution | |
SteppedEquation | Expression is a generic following method |
CoordinateDistribution | |
CoordinateNormalDistribution | |
CoordinateUniformDistribution | |
CoordinateGridDistribution | |
GeometricGenerator | |
Teuchos | |
Zoltan2_BoxBoundaries | Zoltan2_BoxBoundaries is a reduction operation to all reduce the all box boundaries |
MultiJaggedCombinedReductionOp | |
MultiJaggedCombinedMinMaxTotalReductionOp | |
Zoltan2_ReduceBestMapping | Zoltan2_ReduceBestMapping Class, reduces the minimum cost mapping, ties breaks with minimum proc id |
validXML | |
Zoltan2 | Created by mbenlioglu on Aug 31, 2020 |
Details | |
Impl | |
AlgTwoGhostLayer | |
AlgDistance1TwoGhostLayer | |
AlgDistance1 | |
AlgDistance2 | |
AlgPartialDistance2 | |
AlgSerialGreedy | |
AlgBlockMapping | |
AlgDefaultMapping | |
GMWM_triplet | |
AlgAMD | |
AlgMetis | |
AlgNatural | |
AlgND | |
AlgRandom | |
AlgRCM | |
AlgSortedDegree | |
Matcher | An implementation of the Matcher interface that operates on Epetra matrices and Graphs |
SortPairs | |
AlgBlock | |
uMultiSortItem | Class for sorting items with multiple values. First sorting with respect to val[0], then val[1] then ... val[count-1]. The last tie breaking is done with index values. Used for task mapping partitioning where the points on a cut line needs to be distributed consistently |
uSortItem | Sort items for quick sort function |
uSignedSortItem | |
Zoltan2_AlgMJ_TrackCallsCounter | |
AlgMJ | Multi Jagged coordinate partitioning algorithm |
Zoltan2_MJArrayType | |
ArrayCombinationReducer | |
ReduceWeightsFunctor | |
ArrayReducer | |
ReduceArrayFunctor | |
Zoltan2_AlgMJ | Multi Jagged coordinate partitioning algorithm |
AlgParMA | |
AlgParMETIS | |
AlgPuLP | |
AlgQuotient | |
AlgSarma | |
AlgPTScotch | |
coordinateModelPartBox | CoordinateModelPartBox Class, represents the boundaries of the box which is a result of a geometric partitioning algorithm |
GridHash | GridHash Class, Hashing Class for part boxes |
AlgMatrix | |
GNO_LNO_PAIR | |
KmeansHeap | KmeansHeap Class, max heap, but holds the minimum values |
KMeansCluster | |
KMeansAlgorithm | KMeansAlgorithm Class that performs clustering of the coordinates, and returns the closest set of coordinates |
CommunicationModel | CommunicationModel Base Class that performs mapping between the coordinate partitioning result |
CoordinateCommunicationModel | CoordinateModelInput Class that performs mapping between the coordinate partitioning result and mpi ranks base on the coordinate results and mpi physical coordinates |
CoordinateTaskMapper | |
AlgZoltan | |
AlgForTestingOnly | |
Algorithm | Algorithm defines the base class for all algorithms |
TPL_Traits | |
TPL_Traits< first_t, first_t > | |
TPL_Traits< ZOLTAN_ID_PTR, second_t > | |
TPL_Traits< first_t, ZOLTAN_ID_PTR > | |
Zoltan2_Directory_Node | |
Zoltan2_DD_Update_Msg | |
Zoltan2_DD_Find_Msg | |
Zoltan2_DD_Remove_Msg | |
Zoltan2_Directory | Zoltan2_Directory is an abstract base class |
Zoltan2_Directory_Simple | |
Zoltan2_Directory_Vector | |
Zoltan2_Directory_Plan | |
Zoltan2_Directory_Comm | |
DebugManager | DebugManager contains the methods that perform output of debug and status messages |
Environment | The user parameters, debug, timing and memory profiling output objects, and error checking methods |
NotImplemented | Exception thrown when a called base-class method is not implemented |
IntegerRangeListValidator | A ParameterList validator for integer range lists |
IntegerRangeListValidatorXMLConverter | XML conversion code for IntegerRangeListValidator |
Machine | MachineClass Base class for representing machine coordinates, networks, etc |
MachineDragonflyRCA | A Dragonfly (e.g. Cori, Trinity, & Theta) Machine Class for task mapping |
MachineDragonflyRCAForTesting | A Dragonfly (e.g. Cori, Trinity, Theta) Machine Class for testing only. A more realistic machine should be used for task mapping (i.e. see Zoltan2_MachineDragonflyRCA.hpp) |
MachineForTesting | A Machine Class for testing only A more realistic machine should be used for task mapping |
MachineRepresentation | MachineRepresentation Class Base class for representing machine coordinates, networks, etc |
DefaultMachine | A Default MachineRepresentation Class |
MachineTorusRCA | An RCA Machine class on Torus Networks |
MachineTorusRCAForTesting | An RCA Machine Class (Torus Networks) for testing only A more realistic machine should be used for task mapping |
MachineTorusTopoMgr | A TopoManager Machine Class on Torus Networks |
MachineTorusBGQTest | A TopoManager Machine Class (Torus Networks) for testing only A more realistic machine should be used for task mapping |
MetricOutputManager | MetricOutputManager handles output of profiling messages |
TimerManager | |
BaseAdapterRoot | BaseAdapter defines methods required by all Adapters |
BaseAdapter | |
AdapterWithCoords | |
VectorAdapter | VectorAdapter defines the interface for vector input |
AdapterWithCoordsWrapper | |
APFMeshAdapter | |
BasicIdentifierAdapter | This class represents a collection of global Identifiers and their associated weights, if any |
BasicKokkosIdentifierAdapter | This class represents a collection of global Identifiers and their associated weights, if any |
BasicVectorAdapter | BasicVectorAdapter represents a vector (plus optional weights) supplied by the user as pointers to strided arrays |
GraphAdapter | GraphAdapter defines the interface for graph-based user data |
IdentifierAdapter | IdentifierAdapter defines the interface for identifiers |
BasicUserTypes | A simple class that can be the User template argument for an InputAdapter |
InputTraits | The traits required of User input classes or structures |
MatrixAdapter | MatrixAdapter defines the adapter interface for matrices |
MeshAdapter | MeshAdapter defines the interface for mesh input |
PamgenMeshAdapter | This class represents a mesh |
TpetraCrsGraphAdapter | Provides access for Zoltan2 to Tpetra::CrsGraph data |
TpetraCrsMatrixAdapter | Provides access for Zoltan2 to Tpetra::CrsMatrix data |
TpetraRowGraphAdapter | Provides access for Zoltan2 to Tpetra::RowGraph data |
TpetraRowMatrixAdapter | Provides access for Zoltan2 to Tpetra::RowMatrix data |
XpetraCrsGraphAdapter | Provides access for Zoltan2 to Xpetra::CrsGraph data |
XpetraCrsMatrixAdapter | Provides access for Zoltan2 to Xpetra::CrsMatrix data |
XpetraMultiVectorAdapter | An adapter for Xpetra::MultiVector |
XpetraTraits | Defines the traits required for Tpetra, Eptra and Xpetra objects |
CommGraphModel | CommGraphModel defines the interface required for communication graph |
CoordinateModel | This class provides geometric coordinates with optional weights to the Zoltan2 algorithm |
GraphModel | GraphModel defines the interface required for graph models |
HyperGraphModel | HyperGraphModel defines the interface required for hyper graph models |
IdentifierModel | IdentifierModel defines the interface for all identifier models |
Model | The base class for all model classes |
ColoringProblem | ColoringProblem sets up coloring problems for the user |
ColoringSolution | The class containing coloring solution |
MappingProblem | MappingProblem enables mapping of a partition (either computed or input) to MPI ranks |
MappingSolution | PartitionMapping maps a solution or an input distribution to ranks |
MatrixPartitioningProblem | MatrixPartitioningProblem sets up partitioning problems for the user |
MatrixPartitioningSolution | A PartitioningSolution is a solution to a partitioning problem |
OrderingProblem | OrderingProblem sets up ordering problems for the user |
OrderingSolution | The class containing ordering solutions |
LocalOrderingSolution | |
GlobalOrderingSolution | |
PartitioningProblem | PartitioningProblem sets up partitioning problems for the user |
PartitioningSolution | A PartitioningSolution is a solution to a partitioning problem |
PartitionMapping | PartitionMapping maps a solution or an input distribution to ranks |
ProblemRoot | ProblemRoot allows ptr storage and safe dynamic_cast of all |
Problem | Problem base class from which other classes (PartitioningProblem, ColoringProblem, OrderingProblem, MatchingProblem, etc.) derive |
Solution | Just a placeholder for now |
TpetraCrsColorer | |
TpetraCrsColorer< Tpetra::BlockCrsMatrix< SC, LO, GO, NO > > | |
ZoltanCrsColorer | |
Zoltan2CrsColorer | |
Zoltan2CrsColorer< Tpetra::BlockCrsMatrix< SC, LO, GO, NO > > | |
BaseClassMetrics | |
perProcessorComponentMetrics | |
EvaluateBaseClassRoot | A base class for EvaluatePartition, EvaluateOrdering, .. |
EvaluateBaseClass | |
EvaluateMapping | A class that computes and returns quality metrics |
EvaluateOrdering | A class that computes and returns quality metrics. base class for the local and global ordering versions |
EvaluateLocalOrdering | |
EvaluateGlobalOrdering | |
EvaluatePartition | A class that computes and returns quality metrics |
GraphMetrics | |
ImbalanceMetrics | |
StridedData | The StridedData class manages lists of weights or coordinates |
Sphynx | |
SphynxProblem | |
type_name | |
gid_set_t | |
lid_set_t | |
IDs | |
Single_GID | |
Multiple_GID | |
Single_User | |
Vector_User | |
Single_User_Single_GID | |
Single_User_Multiple_GID | |
Vector_User_Single_GID | |
Vector_User_Multiple_GID | |
TestManager | |
Zoltan2_TestingFramework | |
EvaluateFactory | ProblemFactory class contains 1 static factory method |
ProblemFactory | ProblemFactory class contains 1 static factory method |
AdapterFactory | |
AdapterWithOptionalCoordinateAdapter | |
AdapterWithTemplateName | |
ColorerTest | |
ComparisonHelper | A class for comparing solutions, metrics, and timing data of Zoltan2 problems |
ComparisonSource | A class used to save problem solutions and timers |
dots | |
gid_struct | |
IDs | |
KokkosVectorAdapter | |
lid_struct | |
MeshCoordinateTest | |
MetricAnalyzer | |
MetricAnalyzerEvaluateOrdering | |
MetricAnalyzerEvaluatePartition | |
MetricAnalyzerInfo | |
OldSchoolVectorAdapterContig | |
OldSchoolVectorAdapterStrided | |
SomeBadType | |
type_name | |
UserInputForTests | |
VerySimpleVectorAdapter | |
Zoltan2Test | |