MueLu
Version of the Day
|
Base class providing routines to visualize aggregates and coarsening information. More...
#include <MueLu_VisualizationHelpers_fwd.hpp>
Public Member Functions | |
RCP< ParameterList > | GetValidParameterList () const |
Protected Member Functions | |
void | writeFileVTKOpening (std::ofstream &fout, std::vector< int > &uniqueFine, std::vector< int > &geomSizesFine) const |
void | writeFileVTKNodes (std::ofstream &fout, std::vector< int > &uniqueFine, Teuchos::RCP< const Map > &nodeMap) const |
void | writeFileVTKData (std::ofstream &fout, std::vector< int > &uniqueFine, LocalOrdinal myAggOffset, ArrayRCP< LocalOrdinal > &vertex2AggId, int myRank) const |
void | writeFileVTKCoordinates (std::ofstream &fout, std::vector< int > &uniqueFine, Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &fx, Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &fy, Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &fz, int dim) const |
void | writeFileVTKCells (std::ofstream &fout, std::vector< int > &uniqueFine, std::vector< LocalOrdinal > &vertices, std::vector< LocalOrdinal > &geomSize) const |
void | writeFileVTKClosing (std::ofstream &fout) const |
void | writePVTU (std::ofstream &pvtu, std::string baseFname, int numProcs, bool bFineEdges=false, bool bCoarseEdges=false) const |
void | buildColormap () const |
std::string | getFileName (int numProcs, int myRank, int level, const Teuchos::ParameterList &pL) const |
std::string | getBaseFileName (int numProcs, int level, const Teuchos::ParameterList &pL) const |
std::string | getPVTUFileName (int numProcs, int myRank, int level, const Teuchos::ParameterList &pL) const |
std::string | replaceAll (std::string result, const std::string &replaceWhat, const std::string &replaceWithWhat) const |
std::vector< int > | makeUnique (std::vector< int > &vertices) const |
replaces node indices in vertices with compressed unique indices, and returns list of unique points More... | |
Static Protected Member Functions | |
static void | doPointCloud (std::vector< int > &vertices, std::vector< int > &geomSizes, LO numLocalAggs, LO numFineNodes) |
static void | doJacks (std::vector< int > &vertices, std::vector< int > &geomSizes, LO numLocalAggs, LO numFineNodes, const std::vector< bool > &isRoot, const ArrayRCP< LO > &vertex2AggId) |
static void | doConvexHulls2D (std::vector< int > &vertices, std::vector< int > &geomSizes, LO numLocalAggs, LO numFineNodes, const std::vector< bool > &isRoot, const ArrayRCP< LO > &vertex2AggId, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &xCoords, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &yCoords) |
static void | doConvexHulls3D (std::vector< int > &vertices, std::vector< int > &geomSizes, LO numLocalAggs, LO numFineNodes, const std::vector< bool > &isRoot, const ArrayRCP< LO > &vertex2AggId, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &xCoords, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &yCoords, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &zCoords) |
static void | doGraphEdges (std::vector< int > &vertices, std::vector< int > &geomSizes, Teuchos::RCP< LWGraph > &G, Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &fx, Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &fy, Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &fz) |
static int | ccw (const myVec2 &a, const myVec2 &b, const myVec2 &c) |
static myVec3 | crossProduct (myVec3 v1, myVec3 v2) |
static double | dotProduct (myVec2 v1, myVec2 v2) |
static double | dotProduct (myVec3 v1, myVec3 v2) |
static bool | isInFront (myVec3 point, myVec3 inPlane, myVec3 n) |
static double | mymagnitude (myVec2 vec) |
static double | mymagnitude (myVec3 vec) |
static double | distance (myVec2 p1, myVec2 p2) |
static double | distance (myVec3 p1, myVec3 p2) |
static myVec2 | vecSubtract (myVec2 v1, myVec2 v2) |
static myVec3 | vecSubtract (myVec3 v1, myVec3 v2) |
static myVec2 | getNorm (myVec2 v) |
static myVec3 | getNorm (myVec3 v1, myVec3 v2, myVec3 v3) |
static double | pointDistFromTri (myVec3 point, myVec3 v1, myVec3 v2, myVec3 v3) |
static std::vector< myTriangle > | processTriangle (std::list< myTriangle > &tris, myTriangle tri, std::list< int > &pointsInFront, myVec3 &barycenter, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &xCoords, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &yCoords, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &zCoords) |
static std::vector< int > | giftWrap (std::vector< myVec2 > &points, std::vector< int > &nodes, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &xCoords, const Teuchos::ArrayRCP< const typename Teuchos::ScalarTraits< Scalar >::coordinateType > &yCoords) |
Constructors/Destructors. | |
VisualizationHelpers () | |
Constructor. More... | |
virtual | ~VisualizationHelpers () |
Destructor. More... | |
Base class providing routines to visualize aggregates and coarsening information.
This class is the base class for the CoarseningVisualizationFactory as well as the AggregationExporterFactory to visualize aggregates or coarsening information from the transfer operators.
Definition at line 15 of file MueLu_VisualizationHelpers_fwd.hpp.
|
inline |
Constructor.
Definition at line 96 of file MueLu_VisualizationHelpers_decl.hpp.
|
inlinevirtual |
Destructor.
Definition at line 99 of file MueLu_VisualizationHelpers_decl.hpp.
RCP< ParameterList > MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::GetValidParameterList | ( | ) | const |
Definition at line 28 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 957 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 969 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 988 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 1014 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 1035 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 1086 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 1093 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 1132 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 924 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 931 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 948 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 42 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 52 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 86 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 180 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 511 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 545 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 552 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 557 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 562 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 567 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 573 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 578 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 583 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 588 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 593 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 598 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 603 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 609 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 616 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 654 of file MueLu_VisualizationHelpers_def.hpp.
|
staticprotected |
Definition at line 791 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
Definition at line 913 of file MueLu_VisualizationHelpers_def.hpp.
|
protected |
replaces node indices in vertices with compressed unique indices, and returns list of unique points
Definition at line 883 of file MueLu_VisualizationHelpers_def.hpp.