MueLu Version of the Day
Loading...
Searching...
No Matches
MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Reference

Base class providing routines to visualize aggregates and coarsening information. More...

#include <MueLu_VisualizationHelpers_decl.hpp>

Inheritance diagram for MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
MueLu::AggregationExportFactory< Scalar, LocalOrdinal, GlobalOrdinal, Node > MueLu::CoarseningVisualizationFactory< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Constructors/Destructors.

 VisualizationHelpers ()
 Constructor.
 
virtual ~VisualizationHelpers ()
 Destructor.
 
RCP< ParameterList > GetValidParameterList () const
 
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
 
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 doCGALConvexHulls2D (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 doCGALConvexHulls3D (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< GraphBase > &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< myTriangleprocessTriangle (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)
 

Detailed Description

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
class MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >

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 115 of file MueLu_VisualizationHelpers_decl.hpp.

Constructor & Destructor Documentation

◆ VisualizationHelpers()

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::VisualizationHelpers ( )
inline

Constructor.

Definition at line 124 of file MueLu_VisualizationHelpers_decl.hpp.

◆ ~VisualizationHelpers()

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
virtual MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::~VisualizationHelpers ( )
inlinevirtual

Destructor.

Definition at line 127 of file MueLu_VisualizationHelpers_decl.hpp.

Member Function Documentation

◆ GetValidParameterList()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< ParameterList > MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::GetValidParameterList ( ) const

Definition at line 74 of file MueLu_VisualizationHelpers_def.hpp.

◆ writeFileVTKOpening()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::writeFileVTKOpening ( std::ofstream & fout,
std::vector< int > & uniqueFine,
std::vector< int > & geomSizesFine ) const
protected

Definition at line 1273 of file MueLu_VisualizationHelpers_def.hpp.

◆ writeFileVTKNodes()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::writeFileVTKNodes ( std::ofstream & fout,
std::vector< int > & uniqueFine,
Teuchos::RCP< const Map > & nodeMap ) const
protected

Definition at line 1285 of file MueLu_VisualizationHelpers_def.hpp.

◆ writeFileVTKData()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::writeFileVTKData ( std::ofstream & fout,
std::vector< int > & uniqueFine,
LocalOrdinal myAggOffset,
ArrayRCP< LocalOrdinal > & vertex2AggId,
int myRank ) const
protected

Definition at line 1306 of file MueLu_VisualizationHelpers_def.hpp.

◆ writeFileVTKCoordinates()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::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
protected

Definition at line 1332 of file MueLu_VisualizationHelpers_def.hpp.

◆ writeFileVTKCells()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::writeFileVTKCells ( std::ofstream & fout,
std::vector< int > & uniqueFine,
std::vector< LocalOrdinal > & vertices,
std::vector< LocalOrdinal > & geomSize ) const
protected

Definition at line 1353 of file MueLu_VisualizationHelpers_def.hpp.

◆ writeFileVTKClosing()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::writeFileVTKClosing ( std::ofstream & fout) const
protected

Definition at line 1405 of file MueLu_VisualizationHelpers_def.hpp.

◆ writePVTU()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::writePVTU ( std::ofstream & pvtu,
std::string baseFname,
int numProcs,
bool bFineEdges = false,
bool bCoarseEdges = false ) const
protected

Definition at line 1413 of file MueLu_VisualizationHelpers_def.hpp.

◆ buildColormap()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::buildColormap ( ) const
protected

Definition at line 1454 of file MueLu_VisualizationHelpers_def.hpp.

◆ getFileName()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::string MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getFileName ( int numProcs,
int myRank,
int level,
const Teuchos::ParameterList & pL ) const
protected

Definition at line 1240 of file MueLu_VisualizationHelpers_def.hpp.

◆ getBaseFileName()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::string MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getBaseFileName ( int numProcs,
int level,
const Teuchos::ParameterList & pL ) const
protected

Definition at line 1247 of file MueLu_VisualizationHelpers_def.hpp.

◆ getPVTUFileName()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::string MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getPVTUFileName ( int numProcs,
int myRank,
int level,
const Teuchos::ParameterList & pL ) const
protected

Definition at line 1264 of file MueLu_VisualizationHelpers_def.hpp.

◆ doPointCloud()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doPointCloud ( std::vector< int > & vertices,
std::vector< int > & geomSizes,
LO numLocalAggs,
LO numFineNodes )
staticprotected

Definition at line 88 of file MueLu_VisualizationHelpers_def.hpp.

◆ doJacks()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doJacks ( std::vector< int > & vertices,
std::vector< int > & geomSizes,
LO numLocalAggs,
LO numFineNodes,
const std::vector< bool > & isRoot,
const ArrayRCP< LO > & vertex2AggId )
staticprotected

Definition at line 99 of file MueLu_VisualizationHelpers_def.hpp.

◆ doConvexHulls2D()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::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 )
staticprotected

Definition at line 135 of file MueLu_VisualizationHelpers_def.hpp.

◆ doConvexHulls3D()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::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 )
staticprotected

Definition at line 338 of file MueLu_VisualizationHelpers_def.hpp.

◆ doCGALConvexHulls2D()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doCGALConvexHulls2D ( 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 )
staticprotected

Definition at line 234 of file MueLu_VisualizationHelpers_def.hpp.

◆ doCGALConvexHulls3D()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doCGALConvexHulls3D ( 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 )
staticprotected

Definition at line 667 of file MueLu_VisualizationHelpers_def.hpp.

◆ doGraphEdges()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doGraphEdges ( std::vector< int > & vertices,
std::vector< int > & geomSizes,
Teuchos::RCP< GraphBase > & 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 )
staticprotected

Definition at line 780 of file MueLu_VisualizationHelpers_def.hpp.

◆ ccw()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
int MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ccw ( const myVec2 & a,
const myVec2 & b,
const myVec2 & c )
staticprotected

Definition at line 815 of file MueLu_VisualizationHelpers_def.hpp.

◆ crossProduct()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
myVec3 MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::crossProduct ( myVec3 v1,
myVec3 v2 )
staticprotected

Definition at line 823 of file MueLu_VisualizationHelpers_def.hpp.

◆ dotProduct() [1/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
double MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dotProduct ( myVec2 v1,
myVec2 v2 )
staticprotected

Definition at line 829 of file MueLu_VisualizationHelpers_def.hpp.

◆ dotProduct() [2/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
double MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dotProduct ( myVec3 v1,
myVec3 v2 )
staticprotected

Definition at line 835 of file MueLu_VisualizationHelpers_def.hpp.

◆ isInFront()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::isInFront ( myVec3 point,
myVec3 inPlane,
myVec3 n )
staticprotected

Definition at line 841 of file MueLu_VisualizationHelpers_def.hpp.

◆ mymagnitude() [1/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
double MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::mymagnitude ( myVec2 vec)
staticprotected

Definition at line 848 of file MueLu_VisualizationHelpers_def.hpp.

◆ mymagnitude() [2/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
double MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::mymagnitude ( myVec3 vec)
staticprotected

Definition at line 854 of file MueLu_VisualizationHelpers_def.hpp.

◆ distance() [1/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
double MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::distance ( myVec2 p1,
myVec2 p2 )
staticprotected

Definition at line 860 of file MueLu_VisualizationHelpers_def.hpp.

◆ distance() [2/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
double MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::distance ( myVec3 p1,
myVec3 p2 )
staticprotected

Definition at line 867 of file MueLu_VisualizationHelpers_def.hpp.

◆ vecSubtract() [1/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
myVec2 MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::vecSubtract ( myVec2 v1,
myVec2 v2 )
staticprotected

Definition at line 873 of file MueLu_VisualizationHelpers_def.hpp.

◆ vecSubtract() [2/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
myVec3 MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::vecSubtract ( myVec3 v1,
myVec3 v2 )
staticprotected

Definition at line 879 of file MueLu_VisualizationHelpers_def.hpp.

◆ getNorm() [1/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
myVec2 MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getNorm ( myVec2 v)
staticprotected

Definition at line 885 of file MueLu_VisualizationHelpers_def.hpp.

◆ getNorm() [2/2]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
myVec3 MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getNorm ( myVec3 v1,
myVec3 v2,
myVec3 v3 )
staticprotected

Definition at line 891 of file MueLu_VisualizationHelpers_def.hpp.

◆ pointDistFromTri()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
double MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::pointDistFromTri ( myVec3 point,
myVec3 v1,
myVec3 v2,
myVec3 v3 )
staticprotected

Definition at line 898 of file MueLu_VisualizationHelpers_def.hpp.

◆ processTriangle()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::vector< myTriangle > MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::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 )
staticprotected

Definition at line 938 of file MueLu_VisualizationHelpers_def.hpp.

◆ giftWrap()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::vector< int > MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::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 )
staticprotected

Definition at line 1096 of file MueLu_VisualizationHelpers_def.hpp.

◆ replaceAll()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::string MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::replaceAll ( std::string result,
const std::string & replaceWhat,
const std::string & replaceWithWhat ) const
protected

Definition at line 1229 of file MueLu_VisualizationHelpers_def.hpp.

◆ makeUnique()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::vector< int > MueLu::VisualizationHelpers< Scalar, LocalOrdinal, GlobalOrdinal, Node >::makeUnique ( std::vector< int > & vertices) const
protected

replaces node indices in vertices with compressed unique indices, and returns list of unique points

Definition at line 1196 of file MueLu_VisualizationHelpers_def.hpp.


The documentation for this class was generated from the following files: