CAdapterForTests | |
CZoltan2::AlgMJ< mj_scalar_t, mj_lno_t, mj_gno_t, mj_part_t > | Multi Jagged coordinate partitioning algorithm |
►CZoltan2::Algorithm< Adapter > | Algorithm defines the base class for all algorithms |
CZoltan2::AlgAMD< Adapter > | |
CZoltan2::AlgBlock< Adapter > | |
CZoltan2::AlgForTestingOnly< Adapter > | |
CZoltan2::AlgNatural< Adapter > | |
CZoltan2::AlgND< Adapter > | |
CZoltan2::AlgParMA< Adapter > | |
CZoltan2::AlgParMETIS< Adapter > | |
CZoltan2::AlgPTScotch< Adapter > | |
CZoltan2::AlgPuLP< Adapter > | |
CZoltan2::AlgRandom< Adapter > | |
CZoltan2::AlgRCM< Adapter > | |
CZoltan2::AlgSerialGreedy< Adapter > | |
CZoltan2::AlgSortedDegree< Adapter > | |
CZoltan2::AlgZoltan< Adapter > | |
CZoltan2::Zoltan2_AlgMJ< Adapter > | Multi Jagged coordinate partitioning algorithm |
►CZoltan2::BaseAdapter< User > | BaseAdapter defines methods required by all Adapters |
►CZoltan2::GraphAdapter< User, UserCoord > | GraphAdapter defines the interface for graph-based user data |
CZoltan2::XpetraCrsGraphAdapter< User, UserCoord > | Provides access for Zoltan2 to Xpetra::CrsGraph data |
►CZoltan2::IdentifierAdapter< User > | IdentifierAdapter defines the interface for identifiers |
CZoltan2::BasicIdentifierAdapter< User > | This class represents a collection of global Identifiers and their associated weights, if any |
►CZoltan2::MatrixAdapter< User, UserCoord > | MatrixAdapter defines the adapter interface for matrices |
CZoltan2::XpetraCrsMatrixAdapter< User, UserCoord > | Provides access for Zoltan2 to Xpetra::CrsMatrix data |
CZoltan2::XpetraRowMatrixAdapter< User, UserCoord > | Provides access for Zoltan2 to Xpetra::RowMatrix data |
►CZoltan2::MeshAdapter< User > | MeshAdapter defines the interface for mesh input |
CZoltan2::APFMeshAdapter< User > | |
CZoltan2::PamgenMeshAdapter< User > | This class represents a mesh |
►CZoltan2::VectorAdapter< User > | VectorAdapter defines the interface for vector input |
CZoltan2::BasicVectorAdapter< User > | BasicVectorAdapter represents a vector (plus optional weights) supplied by the user as pointers to strided arrays |
CZoltan2::XpetraMultiVectorAdapter< User > | An adapter for Xpetra::MultiVector |
►CZoltan2::BaseAdapter< UserCoord > | |
CZoltan2::VectorAdapter< UserCoord > | |
CZoltan2::BasicUserTypes< scalar, lno, gno > | A simple class that can be the User template argument for an InputAdapter |
►CZoltan2::CommunicationModel< part_t, pcoord_t > | CommunicationModel Base Class that performs mapping between the coordinate partitioning result |
CZoltan2::CoordinateCommunicationModel< pcoord_t, tcoord_t, part_t > | CoordinateModelInput Class that performs mapping between the coordinate partitioning result and mpi ranks base on the coordinate results and mpi physical coordinates |
CComparisonHelper | A class for comparing solutions, metrics, and timing data of Zoltan2 problems |
CComparisonSource | A class used to save problem solutions and timers |
►CGeometricGen::CoordinateDistribution< T, lno_t, gno_t > | |
CGeometricGen::CoordinateGridDistribution< T, lno_t, gno_t > | |
CGeometricGen::CoordinateNormalDistribution< T, lno_t, gno_t > | |
CGeometricGen::CoordinateUniformDistribution< T, lno_t, gno_t > | |
CGeometricGen::CoordinateDistribution< scalar_t, lno_t, gno_t > | |
CZoltan2::coordinateModelPartBox< scalar_t, part_t > | CoordinateModelPartBox Class, represents the boundaries of the box which is a result of a geometric partitioning algorithm |
CGeometricGen::CoordinatePoint< T > | |
CGeometricGen::CoordinatePoint< scalar_t > | |
CZoltan2::DebugManager | DebugManager contains the methods that perform output of debug and status messages |
CGeometricGen::DOTS< tMVector_t > | |
CZoltan2::Environment | The user parameters, debug, timing and memory profiling output objects, and error checking methods |
CZoltan2::EvaluatePartition< Adapter > | A class that computes and returns quality metrics |
CGeometricGen::GeometricGenerator< scalar_t, lno_t, gno_t, node_t > | |
CZoltan2::GMWM_triplet< vtx_t, wgt_t > | |
CZoltan2::GNO_LNO_PAIR< gno_t, part_t > | |
CZoltan2::GraphMetricValues< scalar_t > | A class containing the metrics for one measurable item |
CZoltan2::GridHash< scalar_t, part_t > | GridHash Class, Hashing Class for part boxes |
►CGeometricGen::Hole< T > | |
CGeometricGen::CircleHole< T > | |
CGeometricGen::CubeHole< T > | |
CGeometricGen::RectangleHole< T > | |
CGeometricGen::RectangularPrismHole< T > | |
CGeometricGen::SphereHole< T > | |
CGeometricGen::SquareHole< T > | |
CGeometricGen::Hole< scalar_t > | |
CZoltan2::InputTraits< User > | The traits required of User input classes or structures |
CZoltan2::KMeansAlgorithm< IT, WT > | KMeansAlgorithm Class that performs clustering of the coordinates, and returns the closest set of coordinates. Useful to filter the processors, when there are more processors than needed |
CZoltan2::KMeansCluster< IT, WT > | KMeansCluster Class |
CZoltan2::KmeansHeap< IT, WT > | KmeansHeap Class, max heap, but holds the minimum values |
CZoltan2::MachineRepresentation< pcoord_t > | MachineRepresentation Class Finds the coordinate of the processor. Used to find the processor coordinates or graph |
CZoltan2::MachineRepresentation< scalar_t > | |
CZoltan2::MetricOutputManager< T > | MetricOutputManager handles output of profiling messages |
CZoltan2::MetricValues< scalar_t > | A class containing the metrics for one measurable item |
►CZoltan2::Model< Adapter > | The base class for all model classes |
CZoltan2::CoordinateModel< Adapter > | This class provides geometric coordinates with optional weights to the Zoltan2 algorithm |
CZoltan2::GraphModel< Adapter > | GraphModel defines the interface required for graph models |
CZoltan2::HyperGraphModel< Adapter > | HyperGraphModel defines the interface required for hyper graph models |
CZoltan2::IdentifierModel< Adapter > | IdentifierModel defines the interface for all identifier models |
CZoltan2::Model< typename Adapter::base_adapter_t > | |
►CParameterEntryValidator | |
CZoltan2::IntegerRangeListValidator< Integral > | A ParameterList validator for integer range lists |
►CZoltan2::PartitionMapping< Adapter > | PartitionMapping maps a solution or an input distribution to ranks |
CZoltan2::CoordinateTaskMapper< Adapter, part_t > | |
►CZoltan2::Problem< Adapter > | Problem base class from which other classes (PartitioningProblem, ColoringProblem, OrderingProblem, MatchingProblem, etc.) derive |
CZoltan2::ColoringProblem< Adapter > | ColoringProblem sets up coloring problems for the user |
CZoltan2::OrderingProblem< Adapter > | OrderingProblem sets up ordering problems for the user |
CZoltan2::PartitioningProblem< Adapter > | PartitioningProblem sets up partitioning problems for the user |
►CZoltan2::Solution | Just a placeholder for now |
CZoltan2::ColoringSolution< Adapter > | The class containing coloring solution |
CZoltan2::OrderingSolution< lno_t, gno_t > | The class containing ordering solutions |
CZoltan2::PartitioningSolution< Adapter > | A PartitioningSolution is a solution to a partitioning problem |
CZoltan2::SortPairs< key_t, value_t > | |
CZoltan2::StridedData< lno_t, scalar_t > | The StridedData class manages lists of weights or coordinates |
CZoltan2::TimerManager | |
CZoltan2::TPL_Traits< tpl_t, zno_t > | |
CZoltan2::TPL_Traits< tpl_t, tpl_t > | |
CZoltan2::TPL_Traits< zno_t, ZOLTAN_ID_PTR > | |
CZoltan2::TPL_Traits< ZOLTAN_ID_PTR, zno_t > | |
Ctype_name< T > | |
CZoltan2::uMultiSortItem< IT, CT, WT > | 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 |
CUserInputForTests | |
CZoltan2::uSignedSortItem< IT, WT, SIGN > | |
CZoltan2::uSortItem< IT, WT > | Sort items for quick sort function |
►CValidatorXMLConverter | |
CZoltan2::IntegerRangeListValidatorXMLConverter< Integral > | XML conversion code for IntegerRangeListValidator |
►CValueTypeReductionOp | |
CTeuchos::MultiJaggedCombinedMinMaxTotalReductionOp< Ordinal, T > | |
CTeuchos::MultiJaggedCombinedReductionOp< Ordinal, T > | |
CTeuchos::Zoltan2_BoxBoundaries< Ordinal, T > | Zoltan2_BoxBoundaries is a reduction operation to all reduce the all box boundaries |
CTeuchos::Zoltan2_ReduceBestMapping< Ordinal, T > | Zoltan2_ReduceBestMapping Class, reduces the minimum cost mapping, ties breaks with minimum proc id |
►CGeometricGen::WeightDistribution< T, weighttype > | |
CGeometricGen::SteppedEquation< T, weighttype > | Expression is a generic following method |
CGeometricGen::WeightDistribution< scalar_t, scalar_t > | |
CZoltan2::XpetraTraits< User > | Defines the traits required for Tpetra, Eptra and Xpetra objects |