VTK
|
a cell that represents a triangle More...
#include <vtkTriangle.h>
Public Types | |
typedef vtkCell | Superclass |
![]() | |
typedef vtkObject | Superclass |
Public Member Functions | |
virtual vtkTypeBool | IsA (const char *type) |
Return 1 if this class is the same type of (or a subclass of) the named class. More... | |
vtkTriangle * | NewInstance () const |
void | PrintSelf (ostream &os, vtkIndent indent) override |
Methods invoked by print to print information about the object including superclasses. More... | |
vtkCell * | GetEdge (int edgeId) override |
Get the edge specified by edgeId (range 0 to 2) and return that edge's coordinates. More... | |
int | GetCellType () override |
See the vtkCell API for descriptions of these methods. More... | |
int | GetCellDimension () override |
Return the topological dimensional of the cell (0,1,2, or 3). More... | |
int | GetNumberOfEdges () override |
Return the number of edges in the cell. More... | |
int | GetNumberOfFaces () override |
Return the number of faces in the cell. More... | |
vtkCell * | GetFace (int) override |
Return the face cell from the faceId of the cell. More... | |
int | CellBoundary (int subId, const double pcoords[3], vtkIdList *pts) override |
Given parametric coordinates of a point, return the closest cell boundary, and whether the point is inside or outside of the cell. More... | |
void | Contour (double value, vtkDataArray *cellScalars, vtkIncrementalPointLocator *locator, vtkCellArray *verts, vtkCellArray *lines, vtkCellArray *polys, vtkPointData *inPd, vtkPointData *outPd, vtkCellData *inCd, vtkIdType cellId, vtkCellData *outCd) override |
Generate contouring primitives. More... | |
int | EvaluatePosition (const double x[3], double closestPoint[3], int &subId, double pcoords[3], double &dist2, double weights[]) override |
Given a point x[3] return inside(=1), outside(=0) cell, or (-1) computational problem encountered; evaluate parametric coordinates, sub-cell id (!=0 only if cell is composite), distance squared of point x[3] to cell (in particular, the sub-cell indicated), closest point on cell to x[3] (unless closestPoint is null, in which case, the closest point and dist2 are not found), and interpolation weights in cell. More... | |
void | EvaluateLocation (int &subId, const double pcoords[3], double x[3], double *weights) override |
Determine global coordinate (x[3]) from subId and parametric coordinates. More... | |
int | Triangulate (int index, vtkIdList *ptIds, vtkPoints *pts) override |
Generate simplices of proper dimension. More... | |
void | Derivatives (int subId, const double pcoords[3], const double *values, int dim, double *derivs) override |
Compute derivatives given cell subId and parametric coordinates. More... | |
double * | GetParametricCoords () override |
Return a contiguous array of parametric coordinates of the points defining this cell. More... | |
double | ComputeArea () |
A convenience function to compute the area of a vtkTriangle. More... | |
void | Clip (double value, vtkDataArray *cellScalars, vtkIncrementalPointLocator *locator, vtkCellArray *polys, vtkPointData *inPd, vtkPointData *outPd, vtkCellData *inCd, vtkIdType cellId, vtkCellData *outCd, int insideOut) override |
Clip this triangle using scalar value provided. More... | |
void | InterpolateFunctions (const double pcoords[3], double sf[3]) override |
Compute the interpolation functions/derivatives (aka shape functions/derivatives) More... | |
void | InterpolateDerivs (const double pcoords[3], double derivs[6]) override |
int * | GetEdgeArray (int edgeId) |
Return the ids of the vertices defining edge (edgeId ). More... | |
int | IntersectWithLine (const double p1[3], const double p2[3], double tol, double &t, double x[3], double pcoords[3], int &subId) override |
Plane intersection plus in/out test on triangle. More... | |
int | GetParametricCenter (double pcoords[3]) override |
Return the center of the triangle in parametric coordinates. More... | |
double | GetParametricDistance (const double pcoords[3]) override |
Return the distance of the parametric coordinate provided to the cell. More... | |
![]() | |
vtkCell * | NewInstance () const |
void | Initialize (int npts, vtkIdType *pts, vtkPoints *p) |
Initialize cell from outside with point ids and point coordinates specified. More... | |
void | Initialize (int npts, vtkPoints *p) |
Initialize the cell with point coordinates specified. More... | |
virtual void | ShallowCopy (vtkCell *c) |
Copy this cell by reference counting the internal data structures. More... | |
virtual void | DeepCopy (vtkCell *c) |
Copy this cell by completely copying internal data structures. More... | |
virtual int | IsLinear () |
Non-linear cells require special treatment beyond the usual cell type and connectivity list information. More... | |
virtual int | RequiresInitialization () |
Some cells require initialization prior to access. More... | |
virtual void | Initialize () |
virtual int | IsExplicitCell () |
Explicit cells require additional representational information beyond the usual cell type and connectivity list information. More... | |
virtual int | RequiresExplicitFaceRepresentation () |
Determine whether the cell requires explicit face representation, and methods for setting and getting the faces (see vtkPolyhedron for example usage of these methods). More... | |
virtual void | SetFaces (vtkIdType *vtkNotUsed(faces)) |
virtual vtkIdType * | GetFaces () |
vtkPoints * | GetPoints () |
Get the point coordinates for the cell. More... | |
vtkIdType | GetNumberOfPoints () |
Return the number of points in the cell. More... | |
vtkIdList * | GetPointIds () |
Return the list of point ids defining the cell. More... | |
vtkIdType | GetPointId (int ptId) |
For cell point i, return the actual point id. More... | |
void | GetBounds (double bounds[6]) |
Compute cell bounding box (xmin,xmax,ymin,ymax,zmin,zmax). More... | |
double * | GetBounds () |
Compute cell bounding box (xmin,xmax,ymin,ymax,zmin,zmax). More... | |
double | GetLength2 () |
Compute Length squared of cell (i.e., bounding box diagonal squared). More... | |
virtual int | IsPrimaryCell () |
Return whether this cell type has a fixed topology or whether the topology varies depending on the data (e.g., vtkConvexPointSet). More... | |
virtual void | InterpolateFunctions (const double vtkNotUsed(pcoords)[3], double *vtkNotUsed(weight)) |
Compute the interpolation functions/derivatives (aka shape functions/derivatives) No-ops at this level. More... | |
virtual void | InterpolateDerivs (const double vtkNotUsed(pcoords)[3], double *vtkNotUsed(derivs)) |
![]() | |
vtkBaseTypeMacro (vtkObject, vtkObjectBase) | |
virtual void | DebugOn () |
Turn debugging output on. More... | |
virtual void | DebugOff () |
Turn debugging output off. More... | |
bool | GetDebug () |
Get the value of the debug flag. More... | |
void | SetDebug (bool debugFlag) |
Set the value of the debug flag. More... | |
virtual void | Modified () |
Update the modification time for this object. More... | |
virtual vtkMTimeType | GetMTime () |
Return this object's modified time. More... | |
unsigned long | AddObserver (unsigned long event, vtkCommand *, float priority=0.0f) |
Allow people to add/remove/invoke observers (callbacks) to any VTK object. More... | |
unsigned long | AddObserver (const char *event, vtkCommand *, float priority=0.0f) |
vtkCommand * | GetCommand (unsigned long tag) |
void | RemoveObserver (vtkCommand *) |
void | RemoveObservers (unsigned long event, vtkCommand *) |
void | RemoveObservers (const char *event, vtkCommand *) |
vtkTypeBool | HasObserver (unsigned long event, vtkCommand *) |
vtkTypeBool | HasObserver (const char *event, vtkCommand *) |
void | RemoveObserver (unsigned long tag) |
void | RemoveObservers (unsigned long event) |
void | RemoveObservers (const char *event) |
void | RemoveAllObservers () |
vtkTypeBool | HasObserver (unsigned long event) |
vtkTypeBool | HasObserver (const char *event) |
template<class U , class T > | |
unsigned long | AddObserver (unsigned long event, U observer, void(T::*callback)(), float priority=0.0f) |
Overloads to AddObserver that allow developers to add class member functions as callbacks for events. More... | |
template<class U , class T > | |
unsigned long | AddObserver (unsigned long event, U observer, void(T::*callback)(vtkObject *, unsigned long, void *), float priority=0.0f) |
template<class U , class T > | |
unsigned long | AddObserver (unsigned long event, U observer, bool(T::*callback)(vtkObject *, unsigned long, void *), float priority=0.0f) |
Allow user to set the AbortFlagOn() with the return value of the callback method. More... | |
int | InvokeEvent (unsigned long event, void *callData) |
This method invokes an event and return whether the event was aborted or not. More... | |
int | InvokeEvent (const char *event, void *callData) |
int | InvokeEvent (unsigned long event) |
int | InvokeEvent (const char *event) |
![]() | |
const char * | GetClassName () const |
Return the class name as a string. More... | |
virtual void | Delete () |
Delete a VTK object. More... | |
virtual void | FastDelete () |
Delete a reference to this object. More... | |
void | InitializeObjectBase () |
void | Print (ostream &os) |
Print an object to an ostream. More... | |
virtual void | PrintHeader (ostream &os, vtkIndent indent) |
virtual void | PrintTrailer (ostream &os, vtkIndent indent) |
virtual void | Register (vtkObjectBase *o) |
Increase the reference count (mark as used by another object). More... | |
virtual void | UnRegister (vtkObjectBase *o) |
Decrease the reference count (release by another object). More... | |
int | GetReferenceCount () |
Return the current reference count of this object. More... | |
void | SetReferenceCount (int) |
Sets the reference count. More... | |
void | PrintRevisions (ostream &) |
Legacy. More... | |
Static Public Member Functions | |
static vtkTriangle * | New () |
static vtkTypeBool | IsTypeOf (const char *type) |
static vtkTriangle * | SafeDownCast (vtkObjectBase *o) |
static void | InterpolationFunctions (const double pcoords[3], double sf[3]) |
static void | InterpolationDerivs (const double pcoords[3], double derivs[6]) |
static void | TriangleCenter (double p1[3], double p2[3], double p3[3], double center[3]) |
Compute the center of the triangle. More... | |
static double | TriangleArea (double p1[3], double p2[3], double p3[3]) |
Compute the area of a triangle in 3D. More... | |
static double | Circumcircle (double p1[2], double p2[2], double p3[2], double center[2]) |
Compute the circumcenter (center[3]) and radius squared (method return value) of a triangle defined by the three points x1, x2, and x3. More... | |
static int | BarycentricCoords (double x[2], double x1[2], double x2[2], double x3[2], double bcoords[3]) |
Given a 2D point x[2], determine the barycentric coordinates of the point. More... | |
static int | ProjectTo2D (double x1[3], double x2[3], double x3[3], double v1[2], double v2[2], double v3[2]) |
Project triangle defined in 3D to 2D coordinates. More... | |
static void | ComputeNormal (vtkPoints *p, int numPts, vtkIdType *pts, double n[3]) |
Compute the triangle normal from a points list, and a list of point ids that index into the points list. More... | |
static void | ComputeNormal (double v1[3], double v2[3], double v3[3], double n[3]) |
Compute the triangle normal from three points. More... | |
static void | ComputeNormalDirection (double v1[3], double v2[3], double v3[3], double n[3]) |
Compute the (unnormalized) triangle normal direction from three points. More... | |
static int | TrianglesIntersect (double p1[3], double q1[3], double r1[3], double p2[3], double q2[3], double r2[3]) |
static int | PointInTriangle (double x[3], double x1[3], double x2[3], double x3[3], double tol2) |
static void | ComputeQuadric (double x1[3], double x2[3], double x3[3], double quadric[4][4]) |
Calculate the error quadric for this triangle. More... | |
static void | ComputeQuadric (double x1[3], double x2[3], double x3[3], vtkQuadric *quadric) |
![]() | |
static vtkTypeBool | IsTypeOf (const char *type) |
static vtkCell * | SafeDownCast (vtkObjectBase *o) |
![]() | |
static vtkObject * | New () |
Create an object with Debug turned off, modified time initialized to zero, and reference counting on. More... | |
static void | BreakOnError () |
This method is called when vtkErrorMacro executes. More... | |
static void | SetGlobalWarningDisplay (int val) |
This is a global flag that controls whether any debug, warning or error messages are displayed. More... | |
static void | GlobalWarningDisplayOn () |
static void | GlobalWarningDisplayOff () |
static int | GetGlobalWarningDisplay () |
![]() | |
static vtkTypeBool | IsTypeOf (const char *name) |
Return 1 if this class type is the same type of (or a subclass of) the named class. More... | |
static vtkObjectBase * | New () |
Create an object with Debug turned off, modified time initialized to zero, and reference counting on. More... | |
Protected Member Functions | |
virtual vtkObjectBase * | NewInstanceInternal () const |
vtkTriangle () | |
~vtkTriangle () override | |
![]() | |
vtkCell () | |
~vtkCell () override | |
![]() | |
vtkObject () | |
~vtkObject () override | |
void | RegisterInternal (vtkObjectBase *, vtkTypeBool check) override |
void | UnRegisterInternal (vtkObjectBase *, vtkTypeBool check) override |
void | InternalGrabFocus (vtkCommand *mouseEvents, vtkCommand *keypressEvents=nullptr) |
These methods allow a command to exclusively grab all events. More... | |
void | InternalReleaseFocus () |
![]() | |
vtkObjectBase () | |
virtual | ~vtkObjectBase () |
virtual void | CollectRevisions (ostream &) |
virtual void | ReportReferences (vtkGarbageCollector *) |
vtkObjectBase (const vtkObjectBase &) | |
void | operator= (const vtkObjectBase &) |
Protected Attributes | |
vtkLine * | Line |
![]() | |
double | Bounds [6] |
![]() | |
bool | Debug |
vtkTimeStamp | MTime |
vtkSubjectHelper * | SubjectHelper |
![]() | |
vtkAtomicInt32 | ReferenceCount |
vtkWeakPointerBase ** | WeakPointers |
Additional Inherited Members | |
![]() | |
vtkPoints * | Points |
vtkIdList * | PointIds |
a cell that represents a triangle
vtkTriangle is a concrete implementation of vtkCell to represent a triangle located in 3-space.
Definition at line 41 of file vtkTriangle.h.
typedef vtkCell vtkTriangle::Superclass |
Definition at line 45 of file vtkTriangle.h.
|
protected |
|
overrideprotected |
|
static |
|
static |
|
virtual |
Return 1 if this class is the same type of (or a subclass of) the named class.
Returns 0 otherwise. This method works in combination with vtkTypeMacro found in vtkSetGet.h.
Reimplemented from vtkCell.
|
static |
|
protectedvirtual |
Reimplemented from vtkCell.
vtkTriangle* vtkTriangle::NewInstance | ( | ) | const |
|
overridevirtual |
Get the edge specified by edgeId (range 0 to 2) and return that edge's coordinates.
Implements vtkCell.
|
inlineoverridevirtual |
See the vtkCell API for descriptions of these methods.
Implements vtkCell.
Definition at line 58 of file vtkTriangle.h.
|
inlineoverridevirtual |
Return the topological dimensional of the cell (0,1,2, or 3).
Implements vtkCell.
Definition at line 59 of file vtkTriangle.h.
|
inlineoverridevirtual |
Return the number of edges in the cell.
Implements vtkCell.
Definition at line 60 of file vtkTriangle.h.
|
inlineoverridevirtual |
Return the number of faces in the cell.
Implements vtkCell.
Definition at line 61 of file vtkTriangle.h.
Return the face cell from the faceId of the cell.
Implements vtkCell.
Definition at line 62 of file vtkTriangle.h.
|
overridevirtual |
Given parametric coordinates of a point, return the closest cell boundary, and whether the point is inside or outside of the cell.
The cell boundary is defined by a list of points (pts) that specify a face (3D cell), edge (2D cell), or vertex (1D cell). If the return value of the method is != 0, then the point is inside the cell.
Implements vtkCell.
|
overridevirtual |
Generate contouring primitives.
The scalar list cellScalars are scalar values at each cell point. The point locator is essentially a points list that merges points as they are inserted (i.e., prevents duplicates). Contouring primitives can be vertices, lines, or polygons. It is possible to interpolate point data along the edge by providing input and output point data - if outPd is nullptr, then no interpolation is performed. Also, if the output cell data is non-nullptr, the cell data from the contoured cell is passed to the generated contouring primitives. (Note: the CopyAllocate() method must be invoked on both the output cell and point data. The cellId refers to the cell from which the cell data is copied.)
Implements vtkCell.
|
overridevirtual |
Given a point x[3] return inside(=1), outside(=0) cell, or (-1) computational problem encountered; evaluate parametric coordinates, sub-cell id (!=0 only if cell is composite), distance squared of point x[3] to cell (in particular, the sub-cell indicated), closest point on cell to x[3] (unless closestPoint is null, in which case, the closest point and dist2 are not found), and interpolation weights in cell.
(The number of weights is equal to the number of points defining the cell). Note: on rare occasions a -1 is returned from the method. This means that numerical error has occurred and all data returned from this method should be ignored. Also, inside/outside is determine parametrically. That is, a point is inside if it satisfies parametric limits. This can cause problems for cells of topological dimension 2 or less, since a point in 3D can project onto the cell within parametric limits but be "far" from the cell. Thus the value dist2 may be checked to determine true in/out.
Implements vtkCell.
|
overridevirtual |
Determine global coordinate (x[3]) from subId and parametric coordinates.
Also returns interpolation weights. (The number of weights is equal to the number of points in the cell.)
Implements vtkCell.
Generate simplices of proper dimension.
If cell is 3D, tetrahedron are generated; if 2D triangles; if 1D lines; if 0D points. The form of the output is a sequence of points, each n+1 points (where n is topological cell dimension) defining a simplex. The index is a parameter that controls which triangulation to use (if more than one is possible). If numerical degeneracy encountered, 0 is returned, otherwise 1 is returned. This method does not insert new points: all the points that define the simplices are the points that define the cell.
Implements vtkCell.
|
overridevirtual |
Compute derivatives given cell subId and parametric coordinates.
The values array is a series of data value(s) at the cell points. There is a one-to-one correspondence between cell point and data value(s). Dim is the number of data values per cell point. Derivs are derivatives in the x-y-z coordinate directions for each data value. Thus, if computing derivatives for a scalar function in a hexahedron, dim=1, 8 values are supplied, and 3 deriv values are returned (i.e., derivatives in x-y-z directions). On the other hand, if computing derivatives of velocity (vx,vy,vz) dim=3, 24 values are supplied ((vx,vy,vz)1, (vx,vy,vz)2, ....()8), and 9 deriv values are returned ((d(vx)/dx),(d(vx)/dy),(d(vx)/dz), (d(vy)/dx),(d(vy)/dy), (d(vy)/dz), (d(vz)/dx),(d(vz)/dy),(d(vz)/dz)).
Implements vtkCell.
|
overridevirtual |
Return a contiguous array of parametric coordinates of the points defining this cell.
In other words, (px,py,pz, px,py,pz, etc..) The coordinates are ordered consistent with the definition of the point ordering for the cell. This method returns a non-nullptr pointer when the cell is a primary type (i.e., IsPrimaryCell() is true). Note that 3D parametric coordinates are returned no matter what the topological dimension of the cell.
Reimplemented from vtkCell.
double vtkTriangle::ComputeArea | ( | ) |
A convenience function to compute the area of a vtkTriangle.
|
overridevirtual |
Clip this triangle using scalar value provided.
Like contouring, except that it cuts the triangle to produce other triangles.
Implements vtkCell.
Compute the interpolation functions/derivatives (aka shape functions/derivatives)
Definition at line 108 of file vtkTriangle.h.
Definition at line 112 of file vtkTriangle.h.
Return the ids of the vertices defining edge (edgeId
).
Ids are related to the cell, not to the dataset.
|
overridevirtual |
Plane intersection plus in/out test on triangle.
The in/out test is performed using tol as the tolerance.
Implements vtkCell.
Return the center of the triangle in parametric coordinates.
Reimplemented from vtkCell.
Definition at line 248 of file vtkTriangle.h.
Return the distance of the parametric coordinate provided to the cell.
If inside the cell, a distance of zero is returned.
Reimplemented from vtkCell.
|
inlinestatic |
Compute the center of the triangle.
Definition at line 286 of file vtkTriangle.h.
Compute the area of a triangle in 3D.
See also vtkTriangle::ComputeArea()
Definition at line 295 of file vtkTriangle.h.
|
static |
Compute the circumcenter (center[3]) and radius squared (method return value) of a triangle defined by the three points x1, x2, and x3.
(Note that the coordinates are 2D. 3D points can be used but the z-component will be ignored.)
|
static |
Given a 2D point x[2], determine the barycentric coordinates of the point.
Barycentric coordinates are a natural coordinate system for simplices that express a position as a linear combination of the vertices. For a triangle, there are three barycentric coordinates (because there are three vertices), and the sum of the coordinates must equal 1. If a point x is inside a simplex, then all three coordinates will be strictly positive. If two coordinates are zero (so the third =1), then the point x is on a vertex. If one coordinates are zero, the point x is on an edge. In this method, you must specify the vertex coordinates x1->x3. Returns 0 if triangle is degenerate.
|
static |
Project triangle defined in 3D to 2D coordinates.
Returns 0 if degenerate triangle; non-zero value otherwise. Input points are x1->x3; output 2D points are v1->v3.
|
static |
Compute the triangle normal from a points list, and a list of point ids that index into the points list.
|
inlinestatic |
Compute the triangle normal from three points.
Definition at line 270 of file vtkTriangle.h.
|
inlinestatic |
Compute the (unnormalized) triangle normal direction from three points.
Definition at line 255 of file vtkTriangle.h.
|
static |
|
static |
|
static |
Calculate the error quadric for this triangle.
Return the quadric as a 4x4 matrix or a vtkQuadric. (from Peter Lindstrom's Siggraph 2000 paper, "Out-of-Core Simplification of Large Polygonal Models")
|
static |
|
protected |
Definition at line 240 of file vtkTriangle.h.