VTK
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 1234]
oNboost
oNOpenQube
oNvtkParticleTracerBaseNamespace
oNvtkTableBasedClipperClipTables
oNvtkTableBasedClipperTriangulationTables
oNvtkTemporalStreamTracerNamespace
oNvtkTest
oC_ClassInfoClassInfo is for classes, structs, unions, and namespaces
oC_EnumInfoEnumInfo is for enums Constants are at the same level as the Enum, not inside it
oC_FileInfoFileInfo is for header files
oC_FunctionInfoFunctionInfo is for functions and methods
oC_HierarchyEntryThis file contains utility functions for loading and parsing a VTK hierarchy file
oC_HierarchyInfoAll the entries from a hierarchy file
oC_ItemInfoItemInfo just contains an index
oC_MacroInfoStruct to describe a preprocessor symbol
oC_OptionInfoVtkParseMain.h provides argument parsing for the wrapper executables
oC_PreprocessInfoContains all symbols defined thus far (including those defined in any included header files)
oC_StringCacheStringCache provides a simple way of allocating strings centrally
oC_TemplateInfoTemplateInfo holds template definitions
oC_UsingInfoUsingInfo is for using directives
oC_ValueInfoValueInfo is for typedefs, constants, variables, function parameters, and return values
oC_vtkTclVoidFuncArg
oCBSPNode
oCIVFCacheList
oCIVFDataSetInfo
oCParticlePathFilterInternal
oCStreaklineFilterInternal
oCvtkAbstractGridConnectivity
oCvtkAbstractImageInterpolatorInterpolate data values from images
oCvtkAbstractInterpolatedVelocityFieldAn abstract class for obtaining the interpolated velocity values at a point
oCvtkAddMembershipArrayAdd an array to the output indicating membership within an input selection
oCvtkAdjacencyMatrixToEdgeTable
oCvtkAMRCutPlane
oCvtkAMRGaussianPulseSource
oCvtkAMRInterpolatedVelocityFieldA concrete class for obtaining the interpolated velocity values at a point in AMR data
oCvtkAMRResampleFilter
oCvtkAMRSliceFilter
oCvtkAMRToMultiBlockFilter
oCvtkAMRUtilities
oCvtkAnnotationLinkAn algorithm for linking annotations among objects
oCvtkAppendCompositeDataLeavesAppends one or more composite datasets with the same structure together into a single output composite dataset
oCvtkAppendFilterAppends one or more datasets together into a single unstructured grid
oCvtkAppendPointsAppends points of one or more vtkPolyData data sets
oCvtkAppendPolyDataAppends one or more polygonal datasets together
oCvtkAppendSelectionAppends one or more selections together
oCvtkApplyColorsApply colors to a data set
oCvtkApplyIconsApply icons to a data set
oCvtkApproximatingSubdivisionFilterGenerate a subdivision surface using an Approximating Scheme
oCvtkArcParallelEdgeStrategyRoutes parallel edges as arcs
oCvtkArcSourceCreate an arc between two end points
oCvtkAreaContourSpectrumFilterCompute an approximation of the area contour signature (evolution of the area of the input surface along an arc of the Reeb graph)
oCvtkAreaLayoutLayout a vtkTree into a tree map
oCvtkAreaLayoutStrategyAbstract superclass for all area layout strategies
oCvtkArrayCalculatorPerform mathematical operations on data in field data arrays
oCvtkArrayNormComputes L-norms along one dimension of an array
oCvtkArrayToTableConverts one- and two-dimensional vtkArrayData objects to vtkTable
oCvtkArrowSourceAppends a cylinder to a cone to form an arrow
oCvtkAssignAttributeLabels a field as an attribute
oCvtkAssignCoordinatesGiven two(or three) arrays take the values in those arrays and simply assign them to the coordinates of the vertices
oCvtkAssignCoordinatesLayoutStrategyUses array values to set vertex locations
oCvtkAttributeClustering2DLayoutStrategySimple fast 2D graph layout
oCvtkAttributeDataToFieldDataFilterMap attribute data to field data
oCvtkAutoCorrelativeStatisticsA class for univariate auto-correlative statistics
oCvtkAxesCreate an x-y-z axes
oCvtkBandedPolyDataContourFilterGenerate filled contours for vtkPolyData
oCvtkBivariateLinearTableThresholdPerforms line-based thresholding for vtkTable data
oCvtkBlankStructuredGridTranslate point attribute data into a blanking field
oCvtkBlankStructuredGridWithImageBlank a structured grid with an image
oCvtkBlockDistributionA helper class that manages a block distribution of N elements of data
oCvtkBlockIdScalarsGenerates scalars from blocks
oCvtkBlueObeliskDataContains chemical data from the Blue Obelisk Data Repository
oCvtkBlueObeliskDataParserFill a vtkBlueObeliskData container with data from the BODR XML dataset
oCvtkBooleanOperationPolyDataFilter
oCvtkBooleanTextureGenerate 2D texture map based on combinations of inside, outside, and on region boundary
oCvtkBoostBetweennessClusteringImplements graph clustering based on edge betweenness centrality
oCvtkBoostBiconnectedComponentsFind the biconnected components of a graph
oCvtkBoostBrandesCentralityCompute Brandes betweenness centrality on a vtkGraph
oCvtkBoostBreadthFirstSearchBoost breadth_first_search on a vtkGraph
oCvtkBoostBreadthFirstSearchTreeContructs a BFS tree from a graph
oCvtkBoostConnectedComponentsFind the connected components of a graph
oCvtkBoostDividedEdgeBundlingLayout graph edges in directed edge bundles
oCvtkBoostExtractLargestComponentExtract the largest connected component of a graph
oCvtkBoostKruskalMinimumSpanningTreeContructs a minimum spanning tree from a graph and the weighting array
oCvtkBoostLogWeightingGiven an arbitrary-dimension array of doubles, replaces each value x with one of:
oCvtkBoostPrimMinimumSpanningTreeContructs a minimum spanning tree from a graph, start node, and the weighting array
oCvtkBoostRandomSparseArraySourceGenerates a sparse N-way array containing random values
oCvtkBoostSplitTableField"Splits" one-or-more table fields by duplicating rows containing delimited data
oCvtkBoxClipDataSetClip an unstructured grid
oCvtkBoxLayoutStrategyTree map layout that puts vertices in square-ish boxes
oCvtkBridgeCellImplementation of vtkGenericAdaptorCell
oCvtkBridgeCellIteratorImplementation of vtkGenericCellIterator. It is just an example that show how to implement the Generic API. It is also used for testing and evaluating the Generic framework
oCvtkBridgeCellIteratorOnCellListIterate over a list of cells defined on a dataset. See InitWithCells()
oCvtkBridgeCellIteratorOnDataSetIterate over cells of a dataset
oCvtkBridgeCellIteratorOneIterate over one cell only of a dataset
oCvtkBridgeCellIteratorStrategyInterface used by vtkBridgeCellIterator vtkBridgeCellIterator has different behaviors depending on the way it is initialized. vtkBridgeCellIteratorStrategy is the interface for one of those behaviors. Concrete classes are vtkBridgeCellIteratorOnDataSet, vtkBridgeCellIteratorOnDataSetBoundaries, vtkBridgeCellIteratorOnCellBoundaries, vtkBridgeCellIteratorOnCellNeighbors,
oCvtkBridgeDataSetImplementation of vtkGenericDataSet
oCvtkBridgeExportManage Windows system differences
oCvtkBridgePointIteratorImplementation of vtkGenericPointIterator
oCvtkBridgePointIteratorOnCellImplementation of vtkGenericPointIterator
oCvtkBridgePointIteratorOnDataSetImplementation of vtkGenericPointIterator
oCvtkBridgePointIteratorOneIterate over one point of a dataset
oCvtkBrownianPointsAssign random vector to points
oCvtkBSplineTransformCubic b-spline deformation transformation
oCvtkButterflySubdivisionFilterGenerate a subdivision surface using the Butterfly Scheme
oCvtkButtonSourceAbstract class for creating various button types
oCvtkCachingInterpolatedVelocityFieldInterface for obtaining interpolated velocity values
oCvtkCellCentersGenerate points at center of cells
oCvtkCellDataToPointDataMap cell data to point data
oCvtkCellDerivativesCompute derivatives of scalars and vectors
oCvtkCellDistanceSelectorSelect neighbor cells up to a distance
oCvtkCellLocatorInterpolatedVelocityFieldA concrete class for obtaining the interpolated velocity values at a point
oCvtkCellQualityCalculate functions of quality of the elements of a mesh
oCvtkCellTreeLocatorThis class implements the data structures, construction algorithms for fast cell location presented in "Fast, Memory-Efficient Cell location in Unstructured Grids for Visualization" by Christop Garth and Kenneth I. Joy in VisWeek, 2011
oCvtkCenterOfMassFind the center of mass of a set of points
oCvtkCirclePackFrontChainLayoutStrategyLayout a vtkTree into packed circles using the front chain algorithm
oCvtkCirclePackLayoutLayout a vtkTree as a circle packing
oCvtkCirclePackLayoutStrategyAbstract superclass for all circle packing layout strategies
oCvtkCirclePackToPolyDataConverts a tree to a polygonal data representing a circle packing of the hierarchy
oCvtkCircularLayoutStrategyPlaces vertices around a circle
oCvtkCleanPolyDataMerge duplicate points, and/or remove unused points and/or remove degenerate cells
oCvtkClipClosedSurfaceClip a closed surface with a plane collection
oCvtkClipConvexPolyDataClip any dataset with user-specified implicit function or input scalar data
oCvtkClipDataSetClip any dataset with user-specified implicit function or input scalar data
oCvtkClipHyperOctreeClip an hyperoctree with user-specified implicit function or input scalar data
oCvtkClipPolyDataClip polygonal data with user-specified implicit function or input scalar data
oCvtkClipVolumeClip volume data with user-specified implicit function or input scalar data
oCvtkClustering2DLayoutStrategySimple fast 2D graph layout
oCvtkCMLMoleculeReaderRead a CML file and output a vtkMolecule object
oCvtkCoincidentPointsOctree of labels
oCvtkCollapseGraph"Collapses" vertices onto their neighbors
oCvtkCollapseVerticesByArrayCollapse the graph given a vertex array
oCvtkCollectGraphCollect distributed graph
oCvtkCollectPolyDataCollect distributed polydata
oCvtkCollectTableCollect distributed table
oCvtkCommunity2DLayoutStrategySimple fast 2D graph layout that looks for a community array on it's input and strengthens edges within a community and weakens edges not within the community
oCvtkCompositeCutterCut composite data sets with user-specified implicit function
oCvtkCompositeDataGeometryFilterExtract geometry from multi-group data
oCvtkCompositeDataProbeFilterSubclass of vtkProbeFilter which supports composite datasets in the input
oCvtkCompositeInterpolatedVelocityFieldAn abstract class for obtaining the interpolated velocity values at a point
oCvtkCompositeInterpolatedVelocityFieldDataSetsType
oCvtkComputeHistogram2DOutliersCompute the outliers in a set of 2D histograms and extract the corresponding row data
oCvtkConeLayoutStrategyProduce a cone-tree layout for a forest
oCvtkConeSourceGenerate polygonal cone
oCvtkConnectivityFilterExtract data based on geometric connectivity
oCvtkConstrained2DLayoutStrategySimple fast 2D graph layout that looks for a 'constraint' array (vtkDoubleArray). Any entry in the constraint array will indicate the level of impedance a node has to the force calculations during the layout optimization. The array is assumed to be normalized between zero and one, with one being totally constrained, so no force will be applied to the node (i.e. no movement), and zero being full range of movement (no constraints)
oCvtkContextInteractorStyleAn interactor for chart views It observes the user events (mouse events) and propagates them to the scene. If the scene doesn't eat the event, it is propagated to the interactor style superclass
oCvtkContextViewView of the vtkContextScene
oCvtkContingencyStatisticsA class for bivariate correlation contigency tables, conditional probabilities, and information entropy
oCvtkContingencyStatisticsGnuRA class for bivariate correlation contigency tables, conditional probabilities, and information entropy. The p-value are calculated using R
oCvtkContourFilterGenerate isosurfaces/isolines from scalar values
oCvtkContourGridGenerate isosurfaces/isolines from scalar values (specialized for unstructured grids)
oCvtkContourHelperA utility class used by various contour filters
oCvtkContourTriangulatorFill all 2D contours to create polygons
oCvtkConvertSelectionConvert a selection from one type to another
oCvtkConvertSelectionDomainConvert a selection from one domain to another
oCvtkConvexHull2DProduce filled convex hulls around a set of points
oCvtkCorrelativeStatisticsA class for bivariate linear correlation
oCvtkCorrelativeStatisticsGnuRA class for bivariate linear correlation using R to calculate the p-values
oCvtkCosmicTreeLayoutStrategyTree layout strategy reminiscent of astronomical systems
oCvtkCubeSourceCreate a polygonal representation of a cube
oCvtkCursor2DGenerate a 2D cursor representation
oCvtkCursor3DGenerate a 3D cursor representation
oCvtkCurvaturesCompute curvatures (Gauss and mean) of a Polydata object
oCvtkCutMaterialAutomatically computes the cut plane for a material array pair
oCvtkCutterCut vtkDataSet with user-specified implicit function
oCvtkCylinderSourceGenerate a cylinder centered at origin
oCvtkDashedStreamLineGenerate constant-time dashed streamline in arbitrary dataset
oCvtkDataObjectGeneratorProduces simple (composite or atomic) data sets for testing
oCvtkDataObjectToDataSetFilterMap field data to concrete dataset
oCvtkDataObjectToTableExtract field data as a table
oCvtkDataRepresentationThe superclass for all representations
oCvtkDataSetEdgeSubdivisionCriterionSubclass of vtkEdgeSubdivisionCriterion for vtkDataSet objects
oCvtkDataSetGhostGenerator
oCvtkDataSetGradientComputes scalar field gradient
oCvtkDataSetGradientPrecompute
oCvtkDataSetSurfaceFilterExtracts outer (polygonal) surface
oCvtkDataSetToDataObjectFilterMap dataset into data object (i.e., a field)
oCvtkDataSetTriangleFilterTriangulate any type of dataset
oCvtkDecimatePolylineFilterReduce the number of lines in a polyline
oCvtkDecimateProReduce the number of triangles in a mesh
oCvtkDeformPointSetUse a control polyhedron to deform an input vtkPointSet
oCvtkDelaunay2DCreate 2D Delaunay triangulation of input points
oCvtkDelaunay3DCreate 3D Delaunay triangulation of input points
oCvtkDensifyPolyDataDensify the input by adding points at the centroid
oCvtkDepthSortPolyDataSort poly data along camera view direction
oCvtkDescriptiveStatisticsA class for univariate descriptive statistics
oCvtkDescriptiveStatisticsGnuA class for univariate descriptive statistics using R to calculate p-values
oCvtkDescriptiveStatisticsGnuR
oCvtkDiagonalMatrixSourceGenerates a sparse or dense square matrix with user-specified values for the diagonal, superdiagonal, and subdiagonal
oCvtkDicerAbstract superclass to divide dataset into pieces
oCvtkDijkstraGraphGeodesicPathDijkstra algorithm to compute the graph geodesic
oCvtkDijkstraGraphInternalsHelper class due to PIMPL excess
oCvtkDijkstraImageGeodesicPathDijkstra algorithm to compute the graph geodesic
oCvtkDirectedGraph
oCvtkDiscreteMarchingCubesGenerate object boundaries from labelled volumes
oCvtkDiskSourceCreate a disk with hole in center
oCvtkDistancePolyDataFilter
oCvtkDistributedDataFilterDistribute data among processors
oCvtkDistributedEdgePropertyMapType
oCvtkDistributedVertexPropertyMapType
oCvtkDotProductSimilarityCompute dot-product similarity metrics
oCvtkDSPFilterDefinitionUsed by the Exodus readers
oCvtkDSPFilterGroupUsed by the Exodus readers
oCvtkDuplicatePolyDataFor distributed tiled displays
oCvtkEarthSourceCreate the continents of the Earth as a sphere
oCvtkEdgeCentersGenerate points at center of edges
oCvtkEdgeLayoutLayout graph edges
oCvtkEdgeLayoutStrategyAbstract superclass for all edge layout strategies
oCvtkEdgePointsGenerate points on isosurface
oCvtkEdgeSubdivisionCriterionHow to decide whether a linear approximation to nonlinear geometry or field should be subdivided
oCvtkElevationFilterGenerate scalars along a specified direction
oCvtkEllipticalButtonSourceCreate a ellipsoidal-shaped button
oCvtkEmptyRepresentation
oCvtkExecutionTimerTime filter execution
oCvtkExpandSelectedGraphExpands a selection set of a vtkGraph
oCvtkExtractArrayGiven a vtkArrayData object containing one-or-more vtkArray instances, produces a vtkArrayData containing just one vtkArray, indentified by index
oCvtkExtractArraysOverTimeExtracts a selection over time
oCvtkExtractBlockExtracts blocks from a multiblock dataset
oCvtkExtractCellsSubset a vtkDataSet to create a vtkUnstructuredGrid
oCvtkExtractCTHPartGenerates surface of an CTH volume fraction
oCvtkExtractDataOverTimeExtract point data from a time sequence for a specified point id
oCvtkExtractDataSetsExtracts a number of datasets
oCvtkExtractEdgesExtract cell edges from any type of data
oCvtkExtractGeometryExtract cells that lie either entirely inside or outside of a specified implicit function
oCvtkExtractGridSelect piece (e.g., volume of interest) and/or subsample structured grid dataset
oCvtkExtractHistogram2DCompute a 2D histogram between two columns of an input vtkTable
oCvtkExtractLevelExtract levels between min and max from a hierarchical box dataset
oCvtkExtractPiece
oCvtkExtractPolyDataGeometryExtract vtkPolyData cells that lies either entirely inside or outside of a specified implicit function
oCvtkExtractPolyDataPieceReturn specified piece, including specified number of ghost levels
oCvtkExtractRectilinearGridExtract a sub grid (VOI) from the structured rectilinear dataset
oCvtkExtractSelectedBlock
oCvtkExtractSelectedFrustumReturns the portion of the input dataset that lies within a selection frustum
oCvtkExtractSelectedGraphReturn a subgraph of a vtkGraph
oCvtkExtractSelectedIdsExtract a list of cells from a dataset
oCvtkExtractSelectedLocationsExtract cells within a dataset that contain the locations listen in the vtkSelection
oCvtkExtractSelectedPolyDataIdsExtract a list of cells from a polydata
oCvtkExtractSelectedRowsReturn selected rows of a table
oCvtkExtractSelectedThresholdsExtract a cells or points from a dataset that have values within a set of thresholds
oCvtkExtractSelectedTreeReturn a subtree from a vtkTree
oCvtkExtractSelectionExtract a subset from a vtkDataSet
oCvtkExtractSelectionBaseAbstract base class for all extract selection filters
oCvtkExtractTemporalFieldDataExtract temporal arrays from input field data
oCvtkExtractTensorComponentsExtract parts of tensor and create a scalar, vector, normal, or texture coordinates
oCvtkExtractUnstructuredGridExtract subset of unstructured grid geometry
oCvtkExtractUnstructuredGridPieceReturn specified piece, including specified number of ghost levels
oCvtkExtractUserDefinedPieceReturn user specified piece with ghost cells
oCvtkExtractVectorComponentsExtract components of vector as separate scalars
oCvtkExtractVOISelect piece (e.g., volume of interest) and/or subsample structured points dataset
oCvtkFacetReaderReads a dataset in Facet format
oCvtkFast2DLayoutStrategySimple fast 2D graph layout
oCvtkFastGeomQuadStruct
oCvtkFastSplatterA splatter optimized for splatting single kernels
oCvtkFeatureEdgesExtract boundary, non-manifold, and/or sharp edges from polygonal data
oCvtkFieldDataToAttributeDataFilterMap field data to dataset attribute data
oCvtkFillHolesFilterIdentify and fill holes in meshes
oCvtkForceDirectedLayoutStrategyForce directed graph layout algorithm
oCvtkFrustumSourceCreate a polygonal representation of a frustum
oCvtkGaussianSplatterSplat points into a volume with an elliptical, Gaussian distribution
oCvtkGenerateIndexArray
oCvtkGenericClipClip any dataset with an implicit function or scalar data
oCvtkGenericContourFilterGenerate isocontours from input dataset
oCvtkGenericCutterCut a vtkGenericDataSet with an implicit function or scalar data
oCvtkGenericDataSetTessellatorTessellates generic, higher-order datasets into linear cells
oCvtkGenericGeometryFilterExtract geometry from data (or convert data to polygonal type)
oCvtkGenericGlyph3DFilterCopy oriented and scaled glyph geometry to every input point
oCvtkGenericOutlineFilterCreate wireframe outline for arbitrary generic data set
oCvtkGenericProbeFilterSample data values at specified point locations
oCvtkGenericStreamTracerStreamline generator
oCvtkGeodesicPathAbstract base for classes that generate a geodesic path
oCvtkGeoEdgeStrategyLayout graph edges on a globe as arcs
oCvtkGeoMathUseful geographic calculations
oCvtkGeometryFilterExtract geometry from data (or convert data to polygonal type)
oCvtkGeoViewA 3D geospatial view
oCvtkGeoView2DA 2D geospatial view
oCvtkGhostArray
oCvtkGlyph2DCopy oriented and scaled glyph geometry to every input point (2D specialization)
oCvtkGlyph3DCopy oriented and scaled glyph geometry to every input point
oCvtkGlyphSource2DCreate 2D glyphs represented by vtkPolyData
oCvtkGradientFilterA general filter for gradient estimation
oCvtkGraphAnnotationLayersFilterProduce filled convex hulls around subsets of vertices in a vtkGraph
oCvtkGraphGeodesicPathAbstract base for classes that generate a geodesic path on a graph (mesh)
oCvtkGraphHierarchicalBundleEdgesLayout graph arcs in bundles
oCvtkGraphItemA 2D graphics item for rendering a graph
oCvtkGraphLayoutLayout a graph in 2 or 3 dimensions
oCvtkGraphLayoutFilterNice layout of undirected graphs in 3D
oCvtkGraphLayoutStrategyAbstract superclass for all graph layout strategies
oCvtkGraphLayoutViewLays out and displays a graph
oCvtkGraphToPointsConvert a vtkGraph a set of points
oCvtkGraphToPolyDataConvert a vtkGraph to vtkPolyData
oCvtkGraphWeightEuclideanDistanceFilterWeights the edges of a graph based on the Euclidean distance between the points
oCvtkGraphWeightFilterBase class for filters that weight graph edges
oCvtkGreedyTerrainDecimationReduce height field (represented as image) to reduced TIN
oCvtkGridSynchronizedTemplates3DGenerate isosurface from structured grids
oCvtkGridTransformNonlinear warp transformation
oCvtkGroupLeafVerticesFilter that expands a tree, categorizing leaf vertices
oCvtkHedgeHogCreate oriented lines from vector data
oCvtkHierarchicalDataExtractDataSetsExtract a number of datasets
oCvtkHierarchicalDataExtractLevelExtact levels between min and max
oCvtkHierarchicalDataLevelFilterGenerate scalars from levels
oCvtkHierarchicalDataSetGeometryFilterExtract geometry from hierarchical data
oCvtkHierarchicalGraphPipelineHelper class for rendering graphs superimposed on a tree
oCvtkHierarchicalGraphViewAccepts a graph and a hierarchy - currently a tree - and provides a hierarchy-aware display. Currently, this means displaying the hierarchy using a tree layout, then rendering the graph vertices as leaves of the tree with curved graph edges between leaves
oCvtkHullProduce an n-sided convex hull
oCvtkHyperOctreeClipCutPointsGrabberA concrete implementation of vtkHyperOctreePointsGrabber used by vtkClipHyperOctree and vtkHyperOctreeCutter
oCvtkHyperOctreeContourFilterGenerate isosurfaces/isolines from scalar values
oCvtkHyperOctreeCutterCut vtkHyperOctree with user-specified implicit function
oCvtkHyperOctreeDepthAssign tree depth attribute to each cell
oCvtkHyperOctreeDualGridContourFilterGenerate isosurfaces/isolines from scalar values
oCvtkHyperOctreeFractalSourceCreate an octree from a fractal. hyperoctree
oCvtkHyperOctreeLimiterLimit the tree's depth, averaging data from lower level branches into the new leaves at the cut points
oCvtkHyperOctreeSampleFunctionSample an implicit function over an hyperoctree
oCvtkHyperOctreeSurfaceFilterExtracts outer (polygonal) surface
oCvtkHyperOctreeToUniformGridFilterFlat the octree into a uniform grid
oCvtkHyperStreamlineGenerate hyperstreamline in arbitrary dataset
oCvtkHyperTreeGridAxisCutAxis aligned hyper tree grid cut
oCvtkHyperTreeGridGeometryHyper tree grid outer surface
oCvtkHyperTreeGridSourceCreate a synthetic grid of hypertrees
oCvtkHyperTreeGridToUnstructuredGridConvert hyper tree grid to unstructured grid
oCvtkIcicleViewDisplays a tree in a stacked "icicle" view
oCvtkIconGlyphFilterFilter that generates a polydata consisting of quads with texture coordinates referring to a set of icons within a sheet of icons
oCvtkIdFilterGenerate scalars or field data from point and cell ids
oCvtkImage2DIslandPixel
oCvtkImageAccumulateGeneralized histograms up to 3 dimensions
oCvtkImageAnisotropicDiffusion2DEdge preserving smoothing
oCvtkImageAnisotropicDiffusion3DEdge preserving smoothing
oCvtkImageAppendCollects data from multiple inputs into one image
oCvtkImageAppendComponentsCollects components from two inputs into one output
oCvtkImageBlendBlend images together using alpha or opacity
oCvtkImageBSplineCoefficientsConvert image to b-spline knots
oCvtkImageBSplineInternalsBSpline code from P. Thevenaz
oCvtkImageBSplineInterpolatorPerform b-spline interpolation on images
oCvtkImageButterworthHighPassFrequency domain high pass
oCvtkImageButterworthLowPassFrequency domain Low pass
oCvtkImageCacheFilterCaches multiple vtkImageData objects
oCvtkImageCanvasSource2DPaints on a canvas
oCvtkImageCastImage Data type Casting Filter
oCvtkImageChangeInformationModify spacing, origin and extent
oCvtkImageCheckerboardShow two images at once using a checkboard pattern
oCvtkImageCityBlockDistance1,2 or 3D distance map
oCvtkImageClipReduces the image extent of the input
oCvtkImageComplex
oCvtkImageConnectorCreate a binary image of a sphere
oCvtkImageConnectorSeed
oCvtkImageConstantPadMakes image larger by padding with constant
oCvtkImageContinuousDilate3DDilate implemented as a maximum
oCvtkImageContinuousErode3DErosion implemented as a minimum
oCvtkImageConvolveConvolution of an image with a kernel
oCvtkImageCorrelationCorrelation imageof the two inputs
oCvtkImageCursor3DPaints a cursor on top of an image or volume
oCvtkImageDataGeometryFilterExtract geometry for structured points
oCvtkImageDataStreamerInitiates streaming on image data
oCvtkImageDataToPointSetConverts a vtkImageData to a vtkPointSet
oCvtkImageDataToUniformGridConvert vtkImageData to vtkUniformGrid
oCvtkImageDecomposeFilterFilters that execute axes in series
oCvtkImageDifferenceCompares images for regression tests
oCvtkImageDilateErode3DDilates one value and erodes another
oCvtkImageDivergenceDivergence of a vector field
oCvtkImageDotProductDot product of two vector images
oCvtkImageEllipsoidSourceCreate a binary image of an ellipsoid
oCvtkImageEuclideanDistanceComputes 3D Euclidean DT
oCvtkImageEuclideanToPolarConverts 2D Euclidean coordinates to polar
oCvtkImageExtractComponentsOutputs a single component
oCvtkImageFFTFast Fourier Transform
oCvtkImageFlipThis flips an axis of an image. Right becomes left ..
oCvtkImageFourierCenterShifts constant frequency to center for display
oCvtkImageFourierFilterSuperclass that implements complex numbers
oCvtkImageGaussianSmoothPerforms a gaussian convolution
oCvtkImageGaussianSourceCreate an image with Gaussian pixel values
oCvtkImageGradientComputes the gradient vector
oCvtkImageGradientMagnitudeComputes magnitude of the gradient
oCvtkImageGridSourceCreate an image of a grid
oCvtkImageHistogramCompute the histogram for an image
oCvtkImageHistogramStatisticsCompute statistics for an image
oCvtkImageHSIToRGBConverts HSI components to RGB
oCvtkImageHSVToRGBConverts HSV components to RGB
oCvtkImageHybridMedian2DMedian filter that preserves lines and corners
oCvtkImageIdealHighPassSimple frequency domain band pass
oCvtkImageIdealLowPassSimple frequency domain band pass
oCvtkImageInterpolatorInterpolate data values from images
oCvtkImageIslandRemoval2DRemoves small clusters in masks
oCvtkImageIterateFilterMultiple executes per update
oCvtkImageLaplacianComputes divergence of gradient
oCvtkImageLogarithmicScalePasses each pixel through log function
oCvtkImageLogicAnd, or, xor, nand, nor, not
oCvtkImageLuminanceComputes the luminance of the input
oCvtkImageMagnifyMagnify an image by an integer value
oCvtkImageMagnitudeColapses components with magnitude function.
oCvtkImageMandelbrotSourceMandelbrot image
oCvtkImageMapToColorsMap the input image through a lookup table
oCvtkImageMapToRGBAMap the input image through a lookup table
oCvtkImageMapToWindowLevelColorsMap the input image through a lookup table and window / level it
oCvtkImageMarchingCubesGenerate isosurface(s) from volume/images
oCvtkImageMaskCombines a mask and an image
oCvtkImageMaskBitsApplies a bit-mask pattern to each component
oCvtkImageMathematicsAdd, subtract, multiply, divide, invert, sin, cos, exp, log
oCvtkImageMedian3DMedian Filter
oCvtkImageMirrorPadExtra pixels are filled by mirror images
oCvtkImageNoiseSourceCreate an image filled with noise
oCvtkImageNonMaximumSuppressionPerforms non-maximum suppression
oCvtkImageNormalizeNormalizes that scalar components for each point
oCvtkImageOpenClose3DWill perform opening or closing
oCvtkImagePadFilterSuper class for filters that fill in extra pixels
oCvtkImagePermutePermutes axes of input
oCvtkImageQuantizeRGBToIndexGeneralized histograms up to 4 dimensions
oCvtkImageRange3DMax - min of a circular neighborhood
oCvtkImageRectilinearWipeMake a rectilinear combination of two images
oCvtkImageResampleResamples an image to be larger or smaller
oCvtkImageResizeHigh-quality image resizing filter
oCvtkImageResliceReslices a volume along a new set of axes
oCvtkImageResliceToColorsReslice and produce color scalars
oCvtkImageRFFTReverse Fast Fourier Transform
oCvtkImageRGBToHSIConverts RGB components to HSI
oCvtkImageRGBToHSVConverts RGB components to HSV
oCvtkImageSeedConnectivitySeedConnectivity with user defined seeds
oCvtkImageSeparableConvolution3 1D convolutions on an image
oCvtkImageShiftScaleShift and scale an input image
oCvtkImageShrink3DSubsamples an image
oCvtkImageSincInterpolatorPerform sinc interpolation on images
oCvtkImageSinusoidSourceCreate an image with sinusoidal pixel values
oCvtkImageSkeleton2DSkeleton of 2D images
oCvtkImageSlabCombine image slices to form a slab image
oCvtkImageSlabResliceThick slab reformat through data
oCvtkImageSobel2DComputes a vector field using sobel functions
oCvtkImageSobel3DComputes a vector field using sobel functions
oCvtkImageSpatialAlgorithmFilters that operate on pixel neighborhoods
oCvtkImageStencilCombine images via a cookie-cutter operation
oCvtkImageStencilAlgorithmProducer of vtkImageStencilData
oCvtkImageStencilDataEfficient description of an image stencil
oCvtkImageStencilIteratorImage region iterator
oCvtkImageStencilRaster
oCvtkImageStencilSourceGenerate an image stencil
oCvtkImageStencilToImageConvert an image stencil into an image
oCvtkImageThresholdFlexible threshold
oCvtkImageThresholdConnectivityFlood fill an image region
oCvtkImageToAMRFilter to convert any vtkImageData to a vtkOverlappingAMR
oCvtkImageToImageStencilClip an image with a mask image
oCvtkImageToPolyDataFilterGenerate linear primitives (vtkPolyData) from an image
oCvtkImageTranslateExtentChanges extent, nothing else
oCvtkImageVariance3DVariance in a neighborhood
oCvtkImageWeightedSumAdds any number of images, weighting each according to the weight set using this->SetWeights(i,w)
oCvtkImageWrapPadMakes an image larger by wrapping existing data
oCvtkImplicitFunctionToImageStencilClip an image with a function
oCvtkImplicitModellerCompute distance from input geometry on structured point dataset
oCvtkImplicitPolyDataDistance
oCvtkImplicitTextureCoordsGenerate 1D, 2D, or 3D texture coordinates based on implicit function(s)
oCvtkIncrementalForceLayoutIncremental force-directed layout
oCvtkInteractorStyleAreaSelectHoverAn interactor style for an area tree view
oCvtkInteractorStyleTreeMapHoverAn interactor style for a tree map view
oCvtkInterpolateDataSetAttributesInterpolate scalars, vectors, etc. and other dataset attributes
oCvtkInterpolatedVelocityFieldA concrete class for obtaining the interpolated velocity values at a point
oCvtkInterpolatingSubdivisionFilterGenerate a subdivision surface using an Interpolating Scheme
oCvtkInterpolationInfo
oCvtkInterpolationMath
oCvtkInterpolationWeights
oCvtkInterpolatorInternalsInternals for vtkImageInterpolator
oCvtkIntersectionPolyDataFilter
oCvtkJavaCommand
oCvtkJavaVoidFuncArg
oCvtkKCoreDecompositionCompute the k-core decomposition of the input graph
oCvtkKCoreLayoutProduces a layout for a graph labeled with K-Core information
oCvtkKdTreeSelectorSelects point ids using a kd-tree
oCvtkKMeansAssessFunctor
oCvtkKMeansDistanceFunctorMeasure distance from k-means cluster centers
oCvtkKMeansDistanceFunctorCalculatorMeasure distance from k-means cluster centers using a user-specified expression
oCvtkKMeansStatisticsA class for KMeans clustering
oCvtkLassoStencilSourceCreate a stencil from a contour
oCvtkLevelIdScalars
oCvtkLinearExtrusionFilterSweep polygonal data creating a "skirt" from free edges and lines, and lines from vertices
oCvtkLinearSelectorSelect cells intersecting a line (possibly broken)
oCvtkLinearSubdivisionFilterGenerate a subdivision surface using the Linear Scheme
oCvtkLineSourceCreate a line defined by two end points
oCvtkLinkEdgelsLinks edgels together to form digital curves
oCvtkLoopSubdivisionFilterGenerate a subdivision surface using the Loop Scheme
oCvtkMarchingContourFilterGenerate isosurfaces/isolines from scalar values
oCvtkMarchingCubesGenerate isosurface(s) from volume
oCvtkMarchingSquaresGenerate isoline(s) from structured points set
oCvtkMaskFieldsAllow control of which fields get passed to the output
oCvtkMaskPointsSelectively filter points
oCvtkMaskPolyDataSample subset of input polygonal data cells
oCvtkMassPropertiesEstimate volume, area, shape index of triangle mesh
oCvtkMatricizeArrayConvert an array of arbitrary dimensions to a matrix
oCvtkMatrixMathFilterCalculate functions of quality of the elements of a mesh
oCvtkMemoryLimitImageDataStreamerInitiates streaming on image data
oCvtkMergeCellsMerges any number of vtkDataSets back into a single vtkUnstructuredGrid
oCvtkMergeColumnsMerge two columns into a single column
oCvtkMergeDataObjectFilterMerge dataset and data object field to create dataset with attribute data
oCvtkMergeFieldsMerge multiple fields into one
oCvtkMergeFilterExtract separate components of data from different datasets
oCvtkMergeGraphsCombines two graphs
oCvtkMergeTablesCombine two tables
oCvtkMeshQualityCalculate functions of quality of the elements
oCvtkModifiedBSPTreeGenerate axis aligned BBox tree for raycasting and other Locator based searches
oCvtkMoleculeAlgorithmSuperclass for algorithms that operate on vtkMolecules
oCvtkMoleculeMapperMapper that draws vtkMolecule objects
oCvtkMoleculeToAtomBallFilterGenerate polydata with spheres representing atoms
oCvtkMoleculeToBondStickFilterGenerate polydata with cylinders representing bonds
oCvtkMoleculeToPolyDataFilterAbstract filter class
oCvtkMultiBlockDataGroupFilterCollects multiple inputs into one multi-group dataset
oCvtkMultiBlockMergeFilterMerges multiblock inputs into a single multiblock output
oCvtkMultiCorrelativeAssessFunctor
oCvtkMultiCorrelativeStatisticsA class for multivariate linear correlation
oCvtkMultiThresholdThreshold cells within multiple intervals
oCvtkMutableGraphHelperHelper class for building a directed or directed graph
oCvtkNetworkHierarchyFilter that takes a graph and makes a tree out of the network ip addresses in that graph
oCvtkNonOverlappingAMRLevelIdScalarsGenerate scalars from levels
oCvtkNormalizeMatrixVectorsGiven a sparse input matrix, produces a sparse output matrix with each vector normalized to unit length with respect to a p-norm (default p=2)
oCvtkOBBDicerDivide dataset into spatially aggregated pieces
oCvtkOBBNode
oCvtkOBBTreeGenerate oriented bounding box (OBB) tree
oCvtkOpenQubeElectronicDataProvides access to and storage of electronic data calculated by OpenQube
oCvtkOpenQubeMoleculeSourceRead a OpenQube readable file and output a vtkMolecule object
oCvtkOrderStatisticsA class for univariate order statistics
oCvtkOutlineCornerFilterCreate wireframe outline corners for arbitrary data set
oCvtkOutlineCornerSourceCreate wireframe outline corners around bounding box
oCvtkOutlineFilterCreate wireframe outline for arbitrary data set
oCvtkOutlineSourceCreate wireframe outline around bounding box
oCvtkOverlappingAMRLevelIdScalarsGenerate scalars from levels
oCvtkPairwiseExtractHistogram2DCompute a 2D histogram between all adjacent columns of an input vtkTable
oCvtkParallelCoordinatesHistogramRepresentationData representation that takes generic multivariate data and produces a parallel coordinates plot. This plot optionally can draw a histogram-based plot summary
oCvtkParallelCoordinatesRepresentationData representation that takes generic multivariate data and produces a parallel coordinates plot
oCvtkParallelCoordinatesViewView to be used with vtkParallelCoordinatesRepresentation
oCvtkParametricFunctionSourceTessellate parametric functions
oCvtkParticlePathFilterA Parallel Particle tracer for unsteady vector fields
oCvtkParticleTracerA Parallel Particle tracer for unsteady vector fields
oCvtkParticleTracerBaseA particle tracer for vector fields
oCvtkPassArraysPasses a subset of arrays to the output
oCvtkPassThroughShallow copies the input into the output
oCvtkPassThroughEdgeStrategyPasses edge routing information through
oCvtkPassThroughFilterFilter which shallow copies it's input to it's output
oCvtkPassThroughLayoutStrategyLayout strategy that does absolutely nothing
oCvtkPAutoCorrelativeStatisticsA class for parallel auto-correlative statistics
oCvtkPBGLBreadthFirstSearchBreadth-first search on a distributed vtkGraph
oCvtkPBGLCollapseGraphCollapse multiple vertices into a single vertex
oCvtkPBGLCollapseParallelEdgesCollapse multiple vertices into a single vertex
oCvtkPBGLCollectGraphCollects all of the pieces of a distributed vtkGraph into a single, non-distributed vtkGraph
oCvtkPBGLConnectedComponentsCompute connected components for a distributed vtkGraph. For directed graphs, this computes the connected components; for undirected graphs, this computes the strongly-connected components
oCvtkPBGLDistributedGraphHelperEnd namespace boost::graph::distributed
oCvtkPBGLGraphAdapterAdapter to the Parallel Boost Graph Library (http://www.osl.iu.edu/research/pbgl)
oCvtkPBGLGraphSQLReaderRead a vtkGraph from a database
oCvtkPBGLMinimumSpanningTreeMinimum spanning tree of a distributed vtkGraph
oCvtkPBGLRandomGraphSourceGenerates a distributed graph with random edges
oCvtkPBGLRMATGraphSourceDistributed graph with random edges built accorting to the recursive matrix (R-MAT) model
oCvtkPBGLShortestPathsCompute the shortest paths from the origin vertex to all other vertices in a distributed vtkGraph
oCvtkPBGLVertexColoringCompute a vertex coloring for a distributed, undirected vtkGraph, where each vertex has a color distinct from the colors of its adjacent vertices
oCvtkPBivariateLinearTableThresholdPerforms line-based thresholding for vtkTable data in parallel
oCvtkPCAAnalysisFilterPerforms principal component analysis of a set of aligned pointsets
oCvtkPCAStatisticsA class for multivariate principal component analysis
oCvtkPCAStatisticsGnuRA class for multivariate principal component analysis using R to calculate p-values
oCvtkPCellDataToPointDataCompute point arrays from cell arrays
oCvtkPComputeHistogram2DOutliersExtract outlier rows from a vtkTable based on input 2D histograms, in parallel
oCvtkPContingencyStatisticsA class for parallel bivariate contingency statistics
oCvtkPCorrelativeStatisticsA class for parallel bivariate correlative statistics
oCvtkPCosmoHaloFinderFind halos within a cosmology data file
oCvtkPCosmoReaderRead a binary cosmology data file
oCvtkPDataSetGhostGenerator
oCvtkPDescriptiveStatisticsA class for parallel univariate descriptive statistics
oCvtkPeriodicTableAccess to information about the elements
oCvtkPerturbCoincidentVerticesPerturbs vertices that are coincident
oCvtkPExtractArraysOverTimeExtract point or cell data over time (parallel)
oCvtkPExtractHistogram2DCompute a 2D histogram between two columns of an input vtkTable in parallel
oCvtkPieceRequestFilterSets the piece request for upstream filters
oCvtkPieceScalarsSets all cell scalars from the update piece
oCvtkPipelineGraphSourceGraph constructed from a VTK pipeline
oCvtkPipelineSizeCompute the memory required by a pipeline
oCvtkPKdTreeBuild a k-d tree decomposition of a list of points
oCvtkPKMeansStatisitcsA class for parallel k means clustering
oCvtkPKMeansStatistics
oCvtkPlaneSourceCreate an array of quadrilaterals located in a plane
oCvtkPlatonicSolidSourceProduce polygonal Platonic solids
oCvtkPLinearExtrusionFilterSubclass that handles piece invariance
oCvtkPMaskPointsParallel Mask Points
oCvtkPMultiCorrelativeStatisticsA class for parallel bivariate correlative statistics
oCvtkPointDataToCellDataMap point data to cell data
oCvtkPointLoadCompute stress tensors given point load on semi-infinite domain
oCvtkPointSourceCreate a random cloud of points
oCvtkPolyDataConnectivityFilterExtract polygonal data based on geometric connectivity
oCvtkPolyDataNormalsCompute normals for polygonal mesh
oCvtkPolyDataPointSamplerGenerate points from vtkPolyData
oCvtkPolyDataSilhouetteSort polydata along camera view direction
oCvtkPolyDataStreamerStreamer appends input pieces to the output
oCvtkPolyDataToImageStencilUse polydata to mask an image
oCvtkPolyDataToReebGraphFilterGenerate a Reeb graph from a scalar field defined on a vtkPolyData
oCvtkPOrderStatisticsA class for parallel univariate order statistics
oCvtkPOutlineCornerFilterCreate wireframe outline corners for arbitrary data set
oCvtkPOutlineFilterCreate wireframe outline for arbitrary data set
oCvtkPOutlineFilterInternalsCreate wireframe outline (or corners) for arbitrary data set
oCvtkPPairwiseExtractHistogram2DCompute a 2D histogram between all adjacent columns of an input vtkTable in parallel
oCvtkPParticlePathFilterA Parallel Particle tracer for unsteady vector fields
oCvtkPParticleTracerA Parallel Particle tracer for unsteady vector fields
oCvtkPParticleTracerBase
oCvtkPPCAStatisticsA class for parallel principal component analysis
oCvtkPPolyDataNormalsCompute normals for polygonal mesh
oCvtkPProbeFilterProbe dataset in parallel
oCvtkPProjectSphereFilterA filter to 'unroll' a sphere. The unroll longitude is -180
oCvtkPReflectionFilterParallel version of vtkReflectionFilter
oCvtkProbeFilterSample data values at specified point locations
oCvtkProbePolyhedronProbe/interpolate data values in the interior, exterior or of the surface of a closed, manifold polyhedron
oCvtkProbeSelectedLocationsSimilar to vtkExtractSelectedLocations except that it interpolates the point attributes at the probe locations
oCvtkProcessIdScalarsSets cell or point scalars to the processor rank
oCvtkProcrustesAlignmentFilterAligns a set of pointsets together
oCvtkProgrammableAttributeDataFilterManipulate attribute (cell and point) data via a user-specified function
oCvtkProgrammableDataObjectSourceGenerate source data object via a user-specified function
oCvtkProgrammableElectronicDataProvides access to and storage of user-generated vtkImageData that describes electrons
oCvtkProgrammableFilterUser-programmable filter
oCvtkProgrammableGlyphFilterControl the generation and placement of glyphs at input points
oCvtkProgrammableSourceGenerate source dataset via a user-specified function
oCvtkProjectedTerrainPathProject a polyline onto a terrain
oCvtkProjectedTextureAssign texture coordinates for a projected texture
oCvtkProjectSphereFilterA filter to 'unroll' a sphere. The unroll longitude is -180
oCvtkProteinRibbonFilterGenerates protein ribbons
oCvtkPruneTreeFilterPrune a subtree out of a vtkTree
oCvtkPSphereSourceSphere source that supports pieces
oCvtkPStreaklineFilterA Parallel Particle tracer for unsteady vector fields
oCvtkPStreamTracerParallel streamline generators
oCvtkPStructuredGridConnectivity
oCvtkPStructuredGridGhostDataGenerator
oCvtkPTableToStructuredGridVtkTableToStructuredGrid specialization which handles distribution of the input table
oCvtkPTemporalStreamTracer
oCvtkPUniformGridGhostDataGenerator
oCvtkPYoungsMaterialInterfaceParallel reconstruction of material interfaces
oCvtkPythonArgs
oCvtkPythonCommand
oCvtkPythonOverloadCreated in June 2010 by David Gobbi, originally in vtkPythonUtil
oCvtkPythonUtil
oCvtkQtAnnotationViewA VTK view that displays the annotations on its annotation link
oCvtkQtListViewA VTK view based on a Qt List view
oCvtkQtRecordViewSuperclass for QAbstractItemView-based views
oCvtkQtTableRepresentationSet up a vtkTable in a Qt model
oCvtkQtTableViewA VTK view based on a Qt Table view
oCvtkQtTreeViewA VTK view based on a Qt tree view
oCvtkQtViewSuperclass for Qt widget-based views
oCvtkQuadraturePointInterpolator
oCvtkQuadraturePointsGenerator
oCvtkQuadratureSchemeDictionaryGenerator
oCvtkQuadricClusteringReduce the number of triangles in a mesh
oCvtkQuadricDecimationReduce the number of triangles in a mesh
oCvtkQuadRotationalExtrusionFilterSweep polygonal data creating "skirt" from free edges and lines, and lines from vertices
oCvtkQuantizePolyDataPointsQuantizes x,y,z coordinates of points
oCvtkRAdapterThis is a utility class to convert VTK array data and VTK tables to and from Gnu R S expression (SEXP) data structures. It is used with the R .Call interface and the embedded R interpreter
oCvtkRandomAttributeGeneratorGenerate and create random data attributes
oCvtkRandomGraphSourceGraph with random edges
oCvtkRandomLayoutStrategyRandomly places vertices in 2 or 3 dimensions
oCvtkRCalculatorFilter
oCvtkRearrangeFieldsMove/copy fields between field data, point data and cell data
oCvtkRectangularButtonSourceCreate a rectangular button
oCvtkRectilinearGridClipReduces the image extent of the input
oCvtkRectilinearGridGeometryFilterExtract geometry for a rectilinear grid
oCvtkRectilinearGridOutlineFilterCreate wireframe outline for a rectilinear grid
oCvtkRectilinearGridPartitioner
oCvtkRectilinearGridToPointSetConverts a vtkRectilinearGrid to a vtkPointSet
oCvtkRectilinearGridToTetrahedraCreate a Tetrahedral mesh from a RectilinearGrid
oCvtkRectilinearSynchronizedTemplatesGenerate isosurface from rectilinear grid
oCvtkRecursiveDividingCubesCreate points laying on isosurface (using recursive approach)
oCvtkReebGraphSimplificationFilterSimplify an input Reeb graph
oCvtkReebGraphSurfaceSkeletonFilterCompute a skeletal embedding of the Reeb graph of a scalar field defined on a triangulated surface (vtkPolyData)
oCvtkReebGraphToJoinSplitTreeFilterConverts a given Reeb graph either to a join tree or a split tree (respectively the connectivity of the sub- and sur- level sets). Note: if you want to use simplification filters, do so on the input Reeb graph first
oCvtkReebGraphVolumeSkeletonFilterCompute a skeletal embedding of the Reeb graph of a scalar field defined on a tetrahedral mesh (vtkUnstructuredGrid)
oCvtkReflectionFilterReflects a data set across a plane
oCvtkRegressionTester
oCvtkRegularPolygonSourceCreate a regular, n-sided polygon and/or polyline
oCvtkRemoveHiddenDataRemoves the rows/edges/vertices of input data flagged by ann
oCvtkRemoveIsolatedVerticesRemove vertices of a vtkGraph with degree zero
oCvtkRenderedGraphRepresentation
oCvtkRenderedHierarchyRepresentation
oCvtkRenderedRepresentation
oCvtkRenderedSurfaceRepresentationDisplays a geometric dataset as a surface
oCvtkRenderedTreeAreaRepresentation
oCvtkRenderLargeImageUse tiling to generate a large rendering
oCvtkRenderViewA view containing a renderer
oCvtkRenderViewBaseA base view containing a renderer
oCvtkReverseSenseReverse the ordering of polygonal cells and/or vertex normals
oCvtkRibbonFilterCreate oriented ribbons from lines defined in polygonal dataset
oCvtkRInterface
oCvtkROIStencilSourceCreate simple mask shapes
oCvtkRotationalExtrusionFilterSweep polygonal data creating "skirt" from free edges and lines, and lines from vertices
oCvtkRotationFilterDuplicates a data set by rotation about an axis
oCvtkRRandomTableSourceGenerates vtkTables with columns of random numbers using Gnu R
oCvtkRTAnalyticSourceCreate an image for regression testing
oCvtkRuledSurfaceFilterGenerates a surface from a set of lines
oCvtkSampleFunctionSample an implicit function over a structured point set
oCvtkSCurveSplineComputes an interpolating spline using a a SCurve basis
oCvtkSectorSourceCreate a sector of a disk
oCvtkSelectEnclosedPointsMark points as to whether they are inside a closed surface
oCvtkSelectionSourceGenerate selection from given set of ids vtkSelectionSource generates a vtkSelection from a set of (piece id, cell id) pairs. It will only generate the selection values that match UPDATE_PIECE_NUMBER (i.e. piece == UPDATE_PIECE_NUMBER)
oCvtkSelectPolyDataSelect portion of polygonal mesh; generate selection scalars
oCvtkShepardMethodSample unstructured points onto structured points using the method of Shepard
oCvtkShrinkFilterShrink cells composing an arbitrary data set
oCvtkShrinkPolyDataShrink cells composing PolyData
oCvtkSimple2DLayoutStrategySimple 2D graph layout
oCvtkSimple3DCirclesStrategyPlaces vertices on circles in 3D
oCvtkSimpleBondPerceiverCreate a simple guess of a molecule's topology
oCvtkSimpleElevationFilterGenerate scalars along a specified direction
oCvtkSimpleImageFilterExampleSimple example of an image-image filter
oCvtkSliceAndDiceLayoutStrategyHorizontal and vertical slicing tree map layout
oCvtkSliceCubesGenerate isosurface(s) from volume four slices at a time
oCvtkSmoothPolyDataFilterAdjust point positions using Laplacian smoothing
oCvtkSpanTreeLayoutStrategy
oCvtkSparseArrayToTableConverts a sparse array to a vtkTable
oCvtkSpatialRepresentationFilterGenerate polygonal model of spatial search object (i.e., a vtkLocator)
oCvtkSpherePuzzleCreate a polygonal sphere centered at the origin
oCvtkSpherePuzzleArrowsVisualize permutation of the sphere puzzle
oCvtkSphereSourceCreate a polygonal sphere centered at the origin
oCvtkSplineFilterGenerate uniformly subdivided polylines from a set of input polyline using a vtkSpline
oCvtkSplineGraphEdgesSubsample graph edges to make smooth curves
oCvtkSplitColumnComponentsSplit multicomponent table columns
oCvtkSplitFieldSplit a field into single component fields
oCvtkSquarifyLayoutStrategyUses the squarify tree map layout algorithm
oCvtkStackedTreeLayoutStrategyLays out tree in stacked boxes or rings
oCvtkStatisticsAlgorithmBase class for statistics algorithms
oCvtkStatisticsAlgorithmPrivate
oCvtkStrahlerMetricCompute Strahler metric for a tree
oCvtkStreaklineFilterA Parallel Particle tracer for unsteady vector fields
oCvtkStreamerAbstract object implements integration of massless particle through vector field
oCvtkStreamerBaseSuperclass for filters that stream input pipeline
oCvtkStreamGraphCombines two graphs
oCvtkStreamingStatisticsA class for using the statistics filters in a streaming mode
oCvtkStreamingTessellatorAn algorithm that refines an initial simplicial tessellation using edge subdivision
oCvtkStreamLineGenerate streamline in arbitrary dataset
oCvtkStreamPointsGenerate points along streamer separated by constant time increment
oCvtkStreamTracerStreamline generator
oCvtkStringToCategoryCreates a category array from a string array
oCvtkStringToNumericConverts string arrays to numeric arrays
oCvtkStripperCreate triangle strips and/or poly-lines
oCvtkStructuredAMRGridConnectivity
oCvtkStructuredAMRNeighbor
oCvtkStructuredGridClipReduces the image extent of the input
oCvtkStructuredGridConnectivity
oCvtkStructuredGridGeometryFilterExtract geometry for structured grid
oCvtkStructuredGridGhostDataGenerator
oCvtkStructuredGridOutlineFilterCreate wireframe outline for structured grid
oCvtkStructuredGridPartitioner
oCvtkStructuredNeighbor
oCvtkStructuredPointsGeometryFilterObsolete class
oCvtkSubdivideTetraSubdivide one tetrahedron into twelve for every tetra
oCvtkSubPixelPositionEdgelsAdjust edgel locations based on gradients
oCvtkSuperquadricSourceCreate a polygonal superquadric centered at the origin
oCvtkSurfaceReconstructionFilterReconstructs a surface from unorganized points
oCvtkSynchronizedTemplates2DGenerate isoline(s) from a structured points set
oCvtkSynchronizedTemplates3DGenerate isosurface from structured points
oCvtkSynchronizedTemplatesCutter3DGenerate cut surface from structured points
oCvtkTableBasedClipDataSetClip any dataset with a user-specified implicit function or an input scalar point data array
oCvtkTableFFTFFT for table columns
oCvtkTableToArrayConverts a vtkTable to a matrix
oCvtkTableToGraphConvert a vtkTable into a vtkGraph
oCvtkTableToPolyDataFilter used to convert a vtkTable to a vtkPolyData consisting of vertices
oCvtkTableToSparseArrayConverts a vtkTable into a sparse array
oCvtkTableToStructuredGridConverts vtkTable to a vtkStructuredGrid
oCvtkTableToTreeFilterFilter that converts a vtkTable to a vtkTree
oCvtkTclCommand
oCvtkTclCommandArgStruct
oCvtkTclCommandStruct
oCvtkTclInterpStruct
oCvtkTemporalDataSetCacheCache time steps
oCvtkTemporalFractalA source to test AMR data object
oCvtkTemporalInterpolatedVelocityFieldA helper class for interpolating between times during particle tracing
oCvtkTemporalInterpolatorInterpolate datasets between time steps to produce a new dataset
oCvtkTemporalPathLineFilterGenerate a Polydata Pointset from any Dataset
oCvtkTemporalShiftScaleModify the time range/steps of temporal data
oCvtkTemporalSnapToTimeStepModify the time range/steps of temporal data
oCvtkTemporalStatisticsCompute statistics of point or cell data as it changes over time
oCvtkTemporalStreamTracerA Parallel Particle tracer for unsteady vector fields
oCvtkTensorGlyphScale and orient glyph(s) according to tensor eigenvalues and eigenvectors
oCvtkTessellatedBoxSourceCreate a polygonal representation of a box with a given level of subdivision
oCvtkTessellatorFilterApproximate nonlinear FEM elements with simplices
oCvtkTestingUnified VTK regression testing framework
oCvtkTestingInteractorA RenderWindowInteractor for testing
oCvtkTestUtilitiesUtility functions used for regression testing
oCvtkTextSourceCreate polygonal text
oCvtkTexturedSphereSourceCreate a sphere centered at the origin
oCvtkTextureMapToCylinderGenerate texture coordinates by mapping points to cylinder
oCvtkTextureMapToPlaneGenerate texture coordinates by mapping points to plane
oCvtkTextureMapToSphereGenerate texture coordinates by mapping points to sphere
oCvtkThresholdExtracts cells where scalar value in cell satisfies threshold criterion
oCvtkThresholdGraphReturns a subgraph of a vtkGraph
oCvtkThresholdPointsExtracts points whose scalar value satisfies threshold criterion
oCvtkThresholdTableThresholds table rows
oCvtkThresholdTextureCoordsCompute 1D, 2D, or 3D texture coordinates based on scalar threshold
oCvtkTimeSourceCreates a simple time varying data set
oCvtkTimeSourceExample
oCvtkTransferAttributesTransfer data from a graph representation to a tree representation using direct mapping or pedigree ids
oCvtkTransformFilterTransform points and associated normals and vectors
oCvtkTransformPolyDataFilterTransform points and associated normals and vectors for polygonal dataset
oCvtkTransformTextureCoordsTransform (scale, rotate, translate) texture coordinates
oCvtkTransformToGridCreate a grid for a vtkGridTransform
oCvtkTransmitImageDataPieceFor parallel processing, restrict IO to the first process in the cluste.r
oCvtkTransmitPolyDataPieceReturn specified piece, including specified number of ghost levels
oCvtkTransmitRectilinearGridPieceFor parallel processing, restrict IO to the first process in the cluster
oCvtkTransmitStructuredGridPieceFor parallel processing, restrict IO to the first process in the cluster
oCvtkTransmitUnstructuredGridPieceReturn specified piece, including specified number of ghost levels
oCvtkTransposeMatrixComputes the transpose of an input matrix
oCvtkTreeAreaViewAccepts a graph and a hierarchy - currently a tree - and provides a hierarchy-aware display. Currently, this means displaying the hierarchy using a tree ring layout, then rendering the graph vertices as leaves of the tree with curved graph edges between leaves
oCvtkTreeDifferenceFilterCompare two trees
oCvtkTreeFieldAggregatorAggregate field values from the leaves up the tree
oCvtkTreeHeatmapItemA 2D graphics item for rendering a tree and an associated heatmap
oCvtkTreeLayoutStrategyHierarchical layout
oCvtkTreeLevelsFilterAdds level and leaf fields to a vtkTree
oCvtkTreeMapLayoutLayout a vtkTree into a tree map
oCvtkTreeMapLayoutStrategyAbstract superclass for all tree map layout strategies
oCvtkTreeMapToPolyDataConverts a tree to a polygonal data representing a tree map
oCvtkTreeMapViewDisplays a tree as a tree map
oCvtkTreeOrbitLayoutStrategyHierarchical orbital layout
oCvtkTreeRingToPolyDataConverts a tree to a polygonal data representing radial space filling tree
oCvtkTreeRingViewDisplays a tree in concentric rings
oCvtkTriangleFilterConvert input polygons and strips to triangles
oCvtkTriangularTCoords2D texture coordinates based for triangles
oCvtkTriangularTextureGenerate 2D triangular texture map
oCvtkTryDowncastHelper1
oCvtkTryDowncastHelper2
oCvtkTryDowncastHelper3
oCvtkTubeFilterFilter that generates tubes around lines
oCvtkUncertaintyTubeFilterGenerate uncertainty tubes along a polyline
oCvtkUniformGridGhostDataGenerator
oCvtkUnstructuredGridGeometryFilterExtract geometry from an unstructured grid
oCvtkUnstructuredGridToReebGraphFilterGenerate a Reeb graph from a scalar field defined on a vtkUnstructuredGrid
oCvtkVariantBoostSerializationSerialization support for vtkVariant and vtkVariantArray using the Boost.Serialization library
oCvtkVectorDotGenerate scalars from dot product of vectors and normals (e.g., show displacement plot)
oCvtkVectorNormGenerate scalars from Euclidean norm of vectors
oCvtkVertexDegreeAdds an attribute array with the degree of each vertex
oCvtkVertexGlyphFilterMake a vtkPolyData with a vertex on each point
oCvtkViewThe superclass for all views
oCvtkViewThemeSets theme colors for a graphical view
oCvtkViewUpdaterUpdates views automatically
oCvtkVolumeContourSpectrumFilterCompute an approximation of the volume contour signature (evolution of the volume of the input tet-mesh along an arc of the Reeb graph)
oCvtkVoxelContoursToSurfaceFilterCreate surface from contours
oCvtkVoxelModellerConvert an arbitrary dataset to a voxel representation
oCvtkWarpLensDeform geometry by applying lens distortion
oCvtkWarpScalarDeform geometry with scalar data
oCvtkWarpToDeform geometry by warping towards a point
oCvtkWarpVectorDeform geometry with vector data
oCvtkWeightedTransformFilterTransform based on per-point or per-cell weighting functions
oCvtkWindowedSincPolyDataFilterAdjust point positions using a windowed sinc function interpolation kernel
\CvtkYoungsMaterialInterfaceReconstructs material interfaces