VTK
9.0.20210304
|
a cell that represents a 3D orthogonal parallelepiped More...
#include <vtkVoxel.h>
Public Types | |
typedef vtkCell3D | Superclass |
![]() | |
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... | |
vtkVoxel * | NewInstance () const |
void | PrintSelf (ostream &os, vtkIndent indent) override |
Methods invoked by print to print information about the object including superclasses. More... | |
void | GetEdgePoints (vtkIdType edgeId, const vtkIdType *&pts) override |
See vtkCell3D API for description of these methods. More... | |
void | GetEdgePoints (int edgeId, int *&pts) override |
vtkIdType | GetFacePoints (vtkIdType faceId, const vtkIdType *&pts) override |
Get the list of vertices that define a face. More... | |
void | GetFacePoints (int faceId, int *&pts) override |
void | GetEdgeToAdjacentFaces (vtkIdType edgeId, const vtkIdType *&pts) override |
Get the ids of the two adjacent faces to edge of id edgeId. More... | |
vtkIdType | GetFaceToAdjacentFaces (vtkIdType faceId, const vtkIdType *&faces) override |
Get the ids of the adjacent faces to face of id faceId. More... | |
vtkIdType | GetPointToIncidentEdges (vtkIdType pointId, const vtkIdType *&edges) override |
Get the ids of the incident edges to point of id pointId. More... | |
vtkIdType | GetPointToIncidentFaces (vtkIdType pointId, const vtkIdType *&faces) override |
Get the ids of the incident faces point of id pointId. More... | |
vtkIdType | GetPointToOneRingPoints (vtkIdType pointId, const vtkIdType *&pts) override |
Get the ids of a one-ring surrounding point of id pointId. More... | |
double * | GetParametricCoords () override |
Return a contiguous array of parametric coordinates of the points defining this cell. More... | |
bool | GetCentroid (double centroid[3]) const override |
Computes the centroid of the cell. More... | |
bool | IsInsideOut () override |
Returns true if the normals of the vtkCell3D point inside the cell. More... | |
double | ComputeBoundingSphere (double center[3]) const override |
Computes exact bounding sphere of this voxel. More... | |
int | GetCellType () override |
See the vtkCell API for descriptions of these methods. More... | |
int | GetCellDimension () override |
The topological dimension of the cell. 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 * | GetEdge (int edgeId) override |
Return the edge cell from the edgeId of the cell. More... | |
vtkCell * | GetFace (int faceId) 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 | IntersectWithLine (const double p1[3], const double p2[3], double tol, double &t, double x[3], double pcoords[3], int &subId) override |
Intersect with a ray. 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... | |
int | Inflate (double dist) override |
Inflates voxel by moving every faces by dist. More... | |
void | InterpolateFunctions (const double pcoords[3], double weights[8]) override |
Compute the interpolation functions/derivatives (aka shape functions/derivatives) More... | |
void | InterpolateDerivs (const double pcoords[3], double derivs[24]) override |
![]() | |
vtkCell3D * | NewInstance () const |
void | Clip (double value, vtkDataArray *cellScalars, vtkIncrementalPointLocator *locator, vtkCellArray *connectivity, vtkPointData *inPd, vtkPointData *outPd, vtkCellData *inCd, vtkIdType cellId, vtkCellData *outCd, int insideOut) override |
Cut (or clip) the cell based on the input cellScalars and the specified value. More... | |
virtual void | SetMergeTolerance (double) |
Set the tolerance for merging clip intersection points that are near the vertices of cells. More... | |
virtual double | GetMergeTolerance () |
![]() | |
vtkCell * | NewInstance () const |
void | Initialize (int npts, const 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... | |
virtual int | IntersectWithCell (vtkCell *other, double tol=0.0) |
Intersects with an other cell. More... | |
virtual int | IntersectWithCell (vtkCell *other, const vtkBoundingBox &boudingBox, const vtkBoundingBox &otherBoundingBox, double tol=0.0) |
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 | GetParametricCenter (double pcoords[3]) |
Return center of the cell in parametric coordinates. More... | |
virtual double | GetParametricDistance (const double pcoords[3]) |
Return the distance of the parametric coordinate provided to the cell. 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 vtkIdType | GetNumberOfGenerationsFromBase (const char *name) |
Given the name of a base class of this class type, return the distance of inheritance between this class type and the named class (how many generations of inheritance are there between this class and the named class). 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... | |
bool | GetIsInMemkind () const |
A local state flag that remembers whether this object lives in the normal or extended memory space. More... | |
Static Public Member Functions | |
static vtkVoxel * | New () |
static vtkTypeBool | IsTypeOf (const char *type) |
static vtkVoxel * | SafeDownCast (vtkObjectBase *o) |
static void | InterpolationDerivs (const double pcoords[3], double derivs[24]) |
static void | InterpolationFunctions (const double pcoords[3], double weights[8]) |
Compute the interpolation functions. More... | |
static int * | GetTriangleCases (int caseId) |
Return the case table for table-based isocontouring (aka marching cubes style implementations). More... | |
static const vtkIdType * | GetEdgeArray (vtkIdType edgeId) |
Return the ids of the vertices defining edge/face (edgeId /‘faceId’). More... | |
static const vtkIdType * | GetFaceArray (vtkIdType faceId) |
static const vtkIdType * | GetEdgeToAdjacentFacesArray (vtkIdType edgeId) |
Static method version of GetEdgeToAdjacentFaces. More... | |
static const vtkIdType * | GetFaceToAdjacentFacesArray (vtkIdType faceId) |
Static method version of GetFaceToAdjacentFaces. More... | |
static const vtkIdType * | GetPointToIncidentEdgesArray (vtkIdType pointId) |
Static method version of GetPointToIncidentEdgesArray. More... | |
static const vtkIdType * | GetPointToIncidentFacesArray (vtkIdType pointId) |
Static method version of GetPointToIncidentFacesArray. More... | |
static const vtkIdType * | GetPointToOneRingPointsArray (vtkIdType pointId) |
Static method version of GetPointToOneRingPoints. More... | |
static bool | ComputeCentroid (vtkPoints *points, const vtkIdType *pointIds, double centroid[3]) |
Static method version of GetCentroid. More... | |
![]() | |
static vtkTypeBool | IsTypeOf (const char *type) |
static vtkCell3D * | SafeDownCast (vtkObjectBase *o) |
![]() | |
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 vtkIdType | GetNumberOfGenerationsFromBaseType (const char *name) |
Given a the name of a base class of this class type, return the distance of inheritance between this class type and the named class (how many generations of inheritance are there between this class and the named class). More... | |
static vtkObjectBase * | New () |
Create an object with Debug turned off, modified time initialized to zero, and reference counting on. More... | |
static void | SetMemkindDirectory (const char *directoryname) |
The name of a directory, ideally mounted -o dax, to memory map an extended memory space within. More... | |
static bool | GetUsingMemkind () |
A global state flag that controls whether vtkObjects are constructed in the usual way (the default) or within the extended memory space. More... | |
Static Public Attributes | |
static constexpr vtkIdType | NumberOfPoints = 8 |
static constexpr handle on the number of points. More... | |
static constexpr vtkIdType | NumberOfEdges = 12 |
static contexpr handle on the number of faces. More... | |
static constexpr vtkIdType | NumberOfFaces = 6 |
static contexpr handle on the number of edges. More... | |
static constexpr vtkIdType | MaximumFaceSize = 4 |
static contexpr handle on the maximum face size. More... | |
static constexpr vtkIdType | MaximumValence = 3 |
static constexpr handle on the maximum valence of this cell. More... | |
Protected Member Functions | |
virtual vtkObjectBase * | NewInstanceInternal () const |
vtkVoxel () | |
~vtkVoxel () override | |
![]() | |
vtkCell3D () | |
~vtkCell3D () 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 | ReportReferences (vtkGarbageCollector *) |
vtkObjectBase (const vtkObjectBase &) | |
void | operator= (const vtkObjectBase &) |
Additional Inherited Members | |
![]() | |
vtkPoints * | Points |
vtkIdList * | PointIds |
![]() | |
static vtkMallocingFunction | GetCurrentMallocFunction () |
static vtkReallocingFunction | GetCurrentReallocFunction () |
static vtkFreeingFunction | GetCurrentFreeFunction () |
static vtkFreeingFunction | GetAlternateFreeFunction () |
![]() | |
vtkOrderedTriangulator * | Triangulator |
double | MergeTolerance |
vtkTetra * | ClipTetra |
vtkDoubleArray * | ClipScalars |
![]() | |
double | Bounds [6] |
![]() | |
bool | Debug |
vtkTimeStamp | MTime |
vtkSubjectHelper * | SubjectHelper |
![]() | |
std::atomic< int32_t > | ReferenceCount |
vtkWeakPointerBase ** | WeakPointers |
a cell that represents a 3D orthogonal parallelepiped
vtkVoxel is a concrete implementation of vtkCell to represent a 3D orthogonal parallelepiped. Unlike vtkHexahedron, vtkVoxel has interior angles of 90 degrees, and sides are parallel to coordinate axes. This results in large increases in computational performance.
Definition at line 38 of file vtkVoxel.h.
typedef vtkCell3D vtkVoxel::Superclass |
Definition at line 42 of file vtkVoxel.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 vtkCell3D.
|
static |
|
protectedvirtual |
Reimplemented from vtkCell3D.
vtkVoxel* vtkVoxel::NewInstance | ( | ) | const |
|
overridevirtual |
|
overridevirtual |
Implements vtkCell3D.
Get the list of vertices that define a face.
The list is terminated with a negative number. Note that the vertices are 0-offset; that is, they refer to the ids of the cell, not the point ids of the mesh that the cell belongs to. The faceId must range between 0<=faceId<this->GetNumberOfFaces().
Implements vtkCell3D.
|
overridevirtual |
Implements vtkCell3D.
|
overridevirtual |
Get the ids of the two adjacent faces to edge of id edgeId.
The output face ids are sorted from id of lowest rank to highest. Note that the faces are 0-offset; that is, they refer to the ids of the cells, not the face ids of the mesh that the cell belongs to. The edgeId must range between 0<=edgeId<this->GetNumberOfEdges().
Implements vtkCell3D.
|
overridevirtual |
Get the ids of the adjacent faces to face of id faceId.
The order of faces is consistent. They are always ordered in counter clockwise w.r.t. normal orientation. The first id faces[0] corresponds to the face sharing point of id pts[0] where pts is obtained from this->GetFacePoints(faceId, pts), being the "most counter clockwise" oriented w.r.t. face faceId. Note that the faces are 0-offset; that is, they refer to the ids of the cell, not the face ids of the mesh that the cell belongs to. The faceId must be between 0<=faceId<this->GetNumberOfFaces();
Implements vtkCell3D.
|
overridevirtual |
Get the ids of the incident edges to point of id pointId.
Edges are sorted in counter clockwise order w.r.t. bisectrix pointing outside the cell at point of id pointId. The first edge corresponds to the edge containing point of id pts[0], where pts is obtained from this->GetPointToOnRingVertices(pointId, pts). Note that the edges are 0-offset; that is, they refer to the ids of the cell, not the edge ids of the mesh that the cell belongs to. The edgeId must be between 0<=edgeId<this->GetNumberOfEdges();
Implements vtkCell3D.
|
overridevirtual |
Get the ids of the incident faces point of id pointId.
Faces are sorted in counter clockwise order w.r.t. bisectrix pointing outside the cell at point of id pointId. The first face corresponds to the face containing edge of id edges[0], where edges is obtained from this->GetPointToIncidentEdges(pointId, edges), such that face faces[0] is the "most counterclockwise" face incident to point pointId containing edges[0]. Note that the faces are 0-offset; that is, they refer to the ids of the cell, not the face ids of the mesh that the cell belongs to. The pointId must be between 0<=pointId<this->GetNumberOfPoints().
Implements vtkCell3D.
|
overridevirtual |
Get the ids of a one-ring surrounding point of id pointId.
Points are sorted in counter clockwise order w.r.t. bisectrix pointing outside the cell at point of id pointId. The first point corresponds to the point contained in edges[0], where edges is obtained from this->GetPointToIncidentEdges(pointId, edges). Note that the points are 0-offset; that is, they refer to the ids of the cell, not the point ids of the mesh that the cell belongs to. The pointId must be between 0<pointId<this->GetNumberOfPoints().
Implements vtkCell3D.
|
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.
|
overridevirtual |
Computes the centroid of the cell.
Implements vtkCell3D.
|
overridevirtual |
|
overridevirtual |
Computes exact bounding sphere of this voxel.
Reimplemented from vtkCell.
|
inlineoverridevirtual |
See the vtkCell API for descriptions of these methods.
Implements vtkCell.
Definition at line 106 of file vtkVoxel.h.
|
inlineoverridevirtual |
The topological dimension of the cell.
(Satisfies vtkCell API.)
Reimplemented from vtkCell3D.
Definition at line 107 of file vtkVoxel.h.
|
inlineoverridevirtual |
Return the number of edges in the cell.
Implements vtkCell.
Definition at line 108 of file vtkVoxel.h.
|
inlineoverridevirtual |
Return the number of faces in the cell.
Implements vtkCell.
Definition at line 109 of file vtkVoxel.h.
|
overridevirtual |
Return the edge cell from the edgeId of the cell.
Implements vtkCell.
|
overridevirtual |
Return the face cell from the faceId of the cell.
The returned vtkCell is an object owned by this instance, hence the return value must not be deleted by the caller.
Implements vtkCell.
|
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.)
Reimplemented from vtkCell3D.
|
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.
|
overridevirtual |
Intersect with a ray.
Return parametric coordinates (both line and cell) and global intersection coordinates, given ray definition p1[3], p2[3] and tolerance tol. The method returns non-zero value if intersection occurs. A parametric distance t between 0 and 1 along the ray representing the intersection point, the point coordinates x[3] in data coordinates and also pcoords[3] in parametric coordinates. subId is the index within the cell if a composed cell like a triangle strip.
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 |
Inflates voxel by moving every faces by dist.
Since normals are not ambiguous for degenerate voxels, degenerate voxels are inflated correctly. For example, inflating a voxel collapsed to a single point will produce a voxel of width 2 * dist.
Reimplemented from vtkCell3D.
|
static |
|
inlineoverride |
Compute the interpolation functions/derivatives (aka shape functions/derivatives)
Definition at line 142 of file vtkVoxel.h.
|
inlineoverride |
Definition at line 146 of file vtkVoxel.h.
|
static |
Compute the interpolation functions.
This static method is for convenience. Use the member function if you already have an instance of a voxel.
|
static |
Return the case table for table-based isocontouring (aka marching cubes style implementations).
A linear 3D cell with N vertices will have 2**N cases. The returned case array lists three edges in order to produce one output triangle which may be repeated to generate multiple triangles. The list of cases terminates with a -1 entry.
Return the ids of the vertices defining edge/face (edgeId
/‘faceId’).
Ids are related to the cell, not to the dataset.
Static method version of GetEdgeToAdjacentFaces.
Static method version of GetFaceToAdjacentFaces.
Static method version of GetPointToIncidentEdgesArray.
Static method version of GetPointToIncidentFacesArray.
Static method version of GetPointToOneRingPoints.
|
static |
Static method version of GetCentroid.
|
staticconstexpr |
static constexpr handle on the number of points.
Definition at line 77 of file vtkVoxel.h.
|
staticconstexpr |
static contexpr handle on the number of faces.
Definition at line 82 of file vtkVoxel.h.
|
staticconstexpr |
static contexpr handle on the number of edges.
Definition at line 87 of file vtkVoxel.h.
|
staticconstexpr |
static contexpr handle on the maximum face size.
It can also be used to know the number of faces adjacent to one face.
Definition at line 93 of file vtkVoxel.h.
|
staticconstexpr |
static constexpr handle on the maximum valence of this cell.
The valence of a vertex is the number of incident edges (or equivalently faces) to this vertex. It is also equal to the size of a one ring neighborhood of a vertex.
Definition at line 100 of file vtkVoxel.h.