|
| enum | problemType { COMBINATORIAL,
GENERALIZED,
NORMALIZED
} |
| |
| using | scalar_t = double |
| |
| using | lno_t = typename Adapter::lno_t |
| |
| using | gno_t = typename Adapter::gno_t |
| |
| using | node_t = typename Adapter::node_t |
| |
| using | offset_t = typename Adapter::offset_t |
| |
| using | part_t = typename Adapter::part_t |
| |
| using | weight_t = typename Adapter::scalar_t |
| |
| using | graph_t = Tpetra::CrsGraph< lno_t, gno_t, node_t > |
| |
| using | matrix_t = Tpetra::CrsMatrix< scalar_t, lno_t, gno_t, node_t > |
| |
| using | mvector_t = Tpetra::MultiVector< scalar_t, lno_t, gno_t, node_t > |
| |
| using | op_t = Tpetra::Operator< scalar_t, lno_t, gno_t, node_t > |
| |
typedef
Anasazi::MultiVecTraits
< scalar_t, mvector_t > | MVT |
| |
| typedef Adapter::lno_t | lno_t |
| |
| typedef Adapter::gno_t | gno_t |
| |
| typedef Adapter::scalar_t | scalar_t |
| |
| typedef Adapter::part_t | part_t |
| |
|
| | Sphynx (const RCP< const Environment > &env, const RCP< Teuchos::ParameterList > ¶ms, const RCP< Teuchos::ParameterList > &sphynxParams, const RCP< const Comm< int > > &comm, const RCP< const XpetraCrsGraphAdapter< graph_t > > &adapter) |
| |
| void | partition (const Teuchos::RCP< PartitioningSolution< Adapter > > &solution) |
| |
| int | AnasaziWrapper (const int numEigenVectors) |
| |
| template<typename problem_t > |
| void | setPreconditioner (Teuchos::RCP< problem_t > &problem) |
| |
| template<typename problem_t > |
| void | setMueLuPreconditioner (Teuchos::RCP< problem_t > &problem) |
| |
| template<typename problem_t > |
| void | setJacobiPreconditioner (Teuchos::RCP< problem_t > &problem) |
| |
| template<typename problem_t > |
| void | setPolynomialPreconditioner (Teuchos::RCP< problem_t > &problem) |
| |
| void | eigenvecsToCoords (Teuchos::RCP< mvector_t > &eigenVectors, int computedNumEv, Teuchos::RCP< mvector_t > &coordinates) |
| |
| void | computeWeights (std::vector< const weight_t * > vecweights, std::vector< int > strides) |
| |
| void | MJwrapper (const Teuchos::RCP< const mvector_t > &coordinates, std::vector< const weight_t * > weights, std::vector< int > strides, const Teuchos::RCP< PartitioningSolution< Adapter >> &solution) |
| |
| void | setUserEigenvectors (const Teuchos::RCP< mvector_t > &userEvects) |
| |
| void | determineRegularity () |
| |
| void | setDefaults () |
| |
| void | computeLaplacian () |
| |
| void | computeDegreeMatrix () |
| |
| Teuchos::RCP< matrix_t > | computeCombinatorialLaplacian () |
| |
| Teuchos::RCP< matrix_t > | computeNormalizedLaplacian (bool AHat=false) |
| |
| virtual | ~Algorithm () |
| |
| virtual int | localOrder (const RCP< LocalOrderingSolution< lno_t > > &) |
| | Ordering method. More...
|
| |
| virtual int | globalOrder (const RCP< GlobalOrderingSolution< gno_t > > &) |
| | Ordering method. More...
|
| |
| virtual void | color (const RCP< ColoringSolution< Adapter > > &) |
| | Coloring method. More...
|
| |
| virtual void | match () |
| | Matching method. More...
|
| |
| virtual void | partition (const RCP< PartitioningSolution< Adapter > > &) |
| | Partitioning method. More...
|
| |
| virtual void | partitionMatrix (const RCP< MatrixPartitioningSolution< Adapter > > &) |
| | Matrix Partitioning method. More...
|
| |
| virtual void | map (const RCP< MappingSolution< Adapter > > &) |
| | Mapping method. More...
|
| |
| virtual bool | isPartitioningTreeBinary () const |
| | return if algorithm determins tree to be binary More...
|
| |
| virtual void | getPartitionTree (part_t, part_t &, std::vector< part_t > &, std::vector< part_t > &, std::vector< part_t > &, std::vector< part_t > &) const |
| | for partitioning methods, fill arrays with partition tree info More...
|
| |
virtual std::vector
< coordinateModelPartBox > & | getPartBoxesView () const |
| | for partitioning methods, return bounding boxes of the More...
|
| |
| virtual part_t | pointAssign (int, scalar_t *) const |
| | pointAssign method: Available only for some partitioning algorithms More...
|
| |
| virtual void | boxAssign (int, scalar_t *, scalar_t *, size_t &, part_t **) const |
| | boxAssign method: Available only for some partitioning algorithms More...
|
| |
| virtual void | getCommunicationGraph (const PartitioningSolution< Adapter > *, ArrayRCP< part_t > &, ArrayRCP< part_t > &) |
| | returns serial communication graph of a computed partition More...
|
| |
| virtual int | getRankForPart (part_t) |
| | In mapping, returns the rank to which a part is assigned. More...
|
| |
| virtual void | getMyPartsView (part_t &, part_t *&) |
| | In mapping, returns a view of parts assigned to the current rank. More...
|
| |
template<typename Adapter>
class Zoltan2::Sphynx< Adapter >
Definition at line 67 of file Zoltan2_Sphynx.hpp.