GEOS  3.9.2
Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 123]
oCgeos::index::strtree::AbstractSTRtreeBase class for STRtree and SIRtree
oCgeos::algorithm::AngleUtility functions for working with angles
oCgeos::index::bintree::BintreeA BinTree (or "Binary Interval Tree") is a 1-dimensional version of a quadtree
oCgeos::index::strtree::BoundableA spatial object in an AbstractSTRtree
oCgeos::index::strtree::BoundablePairA pair of Boundables, whose leaf items support a distance metric between them
oCgeos::algorithm::BoundaryNodeRuleAn interface for rules which determine whether node points which are in boundaries of lineal geometry components are in the boundary of the parent geometry collection
oCgeos::operation::buffer::BufferBuilderBuilds the buffer geometry for a given input geometry and precision model
oCgeos::operation::buffer::BufferInputLineSimplifierSimplifies a buffer input line to remove concavities with shallow depth
oCgeos::operation::buffer::BufferOpComputes the buffer of a geometry, for both positive and negative buffer distances
oCgeos::operation::buffer::BufferParametersContains the parameters which describe how a buffer should be constructed
oCgeos::operation::buffer::BufferSubgraphA connected subset of the graph of DirectedEdge and geomgraph::Node
oCgeos::operation::polygonize::BuildAreaCreates an areal geometry formed by the constituent linework of given geometry
oCgeos::io::ByteOrderDataInStreamAllows reading an stream of primitive datatypes from an underlying istream, with the representation being in either common byte ordering
oCgeos::io::ByteOrderValuesMethods to read and write primitive datatypes from/to byte sequences, allowing the byte order to be specified
oCgeos::operation::geounion::CascadedPolygonUnionProvides an efficient method of unioning a collection of polygonal geometries
oCgeos::operation::geounion::CascadedUnionProvides an efficient method of unioning a collection of Geometries
oCgeos::algorithm::CentralEndpointIntersectorComputes an approximate intersection of two line segments by taking the most central of the endpoints of the segments
oCgeos::algorithm::CentroidComputes the centroid of a Geometry of any dimension
oCgeos::algorithm::CGAlgorithmsDDImplements basic computational geometry algorithms using extended precision float-point arithmetic
oCgeos::precision::CommonBitsDetermines the maximum number of common most-significant bits in the mantissa of one or numbers
oCgeos::precision::CommonBitsOpProvides versions of Geometry spatial functions which use common bit removal to reduce the likelihood of robustness problems
oCgeos::precision::CommonBitsRemoverAllow computing and removing common mantissa bits from one or more Geometries
oCgeos::operation::valid::ConnectedInteriorTesterThis class tests that the interior of an area Geometry (Polygon or MultiPolygon) is connected
oCgeos::planargraph::algorithm::ConnectedSubgraphFinderFinds all connected Subgraphs of a PlanarGraph
oCgeos::operation::valid::ConsistentAreaTesterChecks that a geomgraph::GeometryGraph representing an area (a geom::Polygon or geom::MultiPolygon) has consistent semantics for area geometries. This check is required for any reasonable polygonal model (including the OGC-SFS model, as well as models which allow ring self-intersection at single points)
oCgeos::algorithm::ConvexHullComputes the convex hull of a Geometry
oCgeos::geom::CoordinateCoordinate is the lightweight class used to store coordinates
oCgeos::geom::CoordinateFilterGeometry classes support the concept of applying a coordinate filter to every coordinate in the Geometry
oCgeos::geom::CoordinateLessThenStrict weak ordering Functor for Coordinate
oCgeos::geom::CoordinateListA list of Coordinates, which may be set to prevent repeated coordinates from occuring in the list
oCgeos::geom::CoordinateSequenceThe internal representation of a list of coordinates inside a Geometry
oCgeos::geom::CoordinateSequenceFactoryA factory to create concrete instances of CoordinateSequences
oCgeos::geom::CoordinateSequenceFilterInterface for classes which provide operations that can be applied to the coordinates in a CoordinateSequence
oCgeos::math::DDWrapper for DoubleDouble higher precision mathematics operations
oCgeos::triangulate::DelaunayTriangulationBuilderA utility class which creates Delaunay Triangulations from collections of points and extract the resulting triangulation edges or triangles as geometries
oCgeos::geom::util::Densifier
oCgeos::geomgraph::DepthA Depth object records the topological depth of the sides of an Edge for up to two Geometries
oCgeos::geom::Dimension
oCgeos::planargraph::DirectedEdgeStarA sorted collection of DirectedEdge which leave a Node in a PlanarGraph
oCgeos::algorithm::distance::DiscreteFrechetDistanceAn algorithm for computing a distance metric which is an approximation to the Frechet Distance based on a discretization of the input geom::Geometry
oCgeos::algorithm::distance::DiscreteHausdorffDistanceAn algorithm for computing a distance metric which is an approximation to the Hausdorff Distance based on a discretization of the input geom::Geometry
oCgeos::algorithm::DistanceFunctions to compute distance between basic geometric structures
oCgeos::operation::distance::DistanceOpFind two points on two geom::Geometrys which lie within a given distance, or else are the nearest points on the geometries (in which case this also provides the distance between the geometries)
oCgeos::algorithm::distance::DistanceToPoint
oCgeos::simplify::DouglasPeuckerLineSimplifierSimplifies a linestring (sequence of points) using the standard Douglas-Peucker algorithm
oCgeos::simplify::DouglasPeuckerSimplifierSimplifies a Geometry using the standard Douglas-Peucker algorithm
oCgeos::operation::overlayng::Edge
oCgeos::geomgraph::EdgeEndModels the end of an edge incident on a node
oCgeos::operation::relate::EdgeEndBuilderComputes the geomgraph::EdgeEnd objects which arise from a noded geomgraph::Edge
oCgeos::geomgraph::EdgeEndStarA EdgeEndStar is an ordered list of EdgeEnds around a node
oCgeos::edgegraph::EdgeGraph
oCgeos::edgegraph::EdgeGraphBuilder
oCgeos::geomgraph::EdgeIntersectionRepresents a point on an edge which intersects with another edge
oCgeos::geomgraph::EdgeIntersectionListA list of edge intersections along an Edge
oCgeos::operation::overlayng::EdgeKey
oCgeos::geomgraph::EdgeListA EdgeList is a list of Edges
oCgeos::operation::overlayng::EdgeMerger
oCgeos::operation::overlayng::EdgeNodingBuilder
oCgeos::geomgraph::EdgeNodingValidatorValidates that a collection of SegmentStrings is correctly noded
oCgeos::operation::polygonize::EdgeRingRepresents a ring of PolygonizeDirectedEdge which form a ring of a polygon. The ring may be either an outer shell or a hole
oCgeos::geomgraph::EdgeRing
oCgeos::geomgraph::index::EdgeSetIntersectorAn EdgeSetIntersector computes all the intersections between the edges in the set
oCgeos::operation::overlay::EdgeSetNoderNodes a set of edges
oCgeos::operation::overlayng::EdgeSourceInfo
oCgeos::operation::linemerge::EdgeStringA sequence of LineMergeDirectedEdge forming one of the lines that will be output by the line-merging process
oCgeos::operation::overlayng::ElevationModelA simple elevation model used to populate missing Z values in overlay results
oCgeos::precision::EnhancedPrecisionOpProvides versions of Geometry spatial functions which use enhanced precision techniques to reduce the likelihood of robustness problems
oCgeos::geom::EnvelopeAn Envelope defines a rectangulare region of the 2D coordinate plane
oCgeos::linearref::ExtractLineByLocationExtracts the subline of a linear Geometry between two LinearLocations on the line
oCgeos::noding::FastNodingValidatorValidates that a collection of SegmentStrings is correctly noded
oCgeos::noding::FastSegmentSetIntersectionFinderFinds if two sets of SegmentStrings intersect
oCgeos::operation::overlay::validate::FuzzyPointLocatorFinds the most likely Location of a point relative to the polygonal components of a geometry, using a tolerance value
oCgeos::util::GeometricShapeFactoryComputes various kinds of common geometric shapes
oCgeos::geom::GeometryBasic implementation of Geometry, constructed and destructed by GeometryFactory
oCgeos::geom::util::GeometryCombinerCombines Geometrys to produce a GeometryCollection of the most appropriate type
oCgeos::geom::GeometryComponentFilter
oCgeos::geom::util::GeometryEditor
oCgeos::geom::util::GeometryEditorOperation
oCgeos::geom::util::GeometryExtracter
oCgeos::geom::GeometryFactorySupplies a set of utility methods for building Geometry objects from CoordinateSequence or other Geometry objects
oCgeos::geom::GeometryFilterGeometry classes support the concept of applying a Geometry filter to the Geometry
oCgeos::operation::GeometryGraphOperationThe base class for operations that require GeometryGraph
oCgeos::operation::geounion::GeometryListHolderHelper class holding Geometries, part of which are held by reference others are held exclusively
oCgeos::operation::distance::GeometryLocationRepresents the location of a point on a Geometry
oCgeos::precision::GeometryPrecisionReducerReduces the precision of a geom::Geometry according to the supplied geom::PrecisionModel, ensuring that the result is valid (unless specified otherwise)
oCgeos::operation::overlay::snap::GeometrySnapperSnaps the vertices and segments of a geom::Geometry to another Geometry's vertices
oCgeos::geom::util::GeometryTransformerA framework for processes which transform an input Geometry into an output Geometry, possibly changing its structure and type(s)
oCgeos::util::GEOSExceptionBase class for all GEOS exceptions
oCgeos::geomgraph::GraphComponentA GraphComponent is the parent class for the objects' that form a graph
oCgeos::planargraph::GraphComponentThe base class for all graph component classes
oCgeos::edgegraph::HalfEdge
oCgeos::algorithm::HCoordinateRepresents a homogeneous coordinate in a 2-D coordinate space
oCgeos::shape::fractal::HilbertCode
oCgeos::operation::polygonize::HoleAssignerAssigns hole rings to shell rings during polygonization
oCgeos::noding::snapround::HotPixelImplements a "hot pixel" as used in the Snap Rounding algorithm
oCgeos::triangulate::IncrementalDelaunayTriangulatorComputes a Delauanay Triangulation of a set of quadedge::Vertexes, using an incrementatal insertion algorithm
oCgeos::operation::distance::IndexedFacetDistanceComputes the distance between the facets (segments and vertices) of two Geometrys using a Branch-and-Bound algorithm
oCgeos::operation::valid::IndexedNestedRingTesterTests whether any of a set of LinearRings are nested inside another ring in the set, using a spatial index to speed up the comparisons
oCgeos::algorithm::InteriorPointAreaComputes a point in the interior of an areal geometry. The point will lie in the geometry interior in all except certain pathological cases
oCgeos::algorithm::InteriorPointLineComputes a point in the interior of an linear geometry
oCgeos::algorithm::InteriorPointPointComputes a point in the interior of an point geometry
oCgeos::util::InterruptUsed to manage interruption requests and callbacks
oCgeos::algorithm::IntersectionComputes the intersection point of two lines. If the lines are parallel or collinear this case is detected and null is returned
oCgeos::geom::IntersectionMatrixImplementation of Dimensionally Extended Nine-Intersection Model (DE-9IM) matrix
oCgeos::operation::overlayng::IntersectionPointBuilder
oCgeos::index::strtree::AbstractSTRtree::IntersectsOpA test for intersection between two bounds, necessary because subclasses of AbstractSTRtree have different implementations of bounds
oCgeos::index::bintree::IntervalRepresents an (1-dimensional) closed interval on the Real number line
oCgeos::index::strtree::IntervalA contiguous portion of 1D-space. Used internally by SIRtree
oCgeos::index::quadtree::IntervalSizeProvides a test for whether an interval is so small it should be considered as zero for the purposes of inserting it into a binary tree
oCgeos::operation::IsSimpleOpTests whether a Geometry is simple
oCgeos::operation::valid::IsValidOpImplements the algorithsm required to compute the isValid() method for Geometrys
oCgeos::index::strtree::ItemDistanceA function method which computes the distance between two ItemBoundables in an STRtree. Used for Nearest Neighbour searches
oCgeos::index::ItemVisitorA visitor for items in an index
oCgeos::index::kdtree::KdNode
oCgeos::index::kdtree::KdTree
oCgeos::index::bintree::KeyA Key is a unique identifier for a node in a tree
oCgeos::index::quadtree::KeyA Key is a unique identifier for a node in a quadtree
oCgeos::geomgraph::LabelA Label indicates the topological relationship of a component of a topology graph to a given Geometry
oCgeos::algorithm::construct::LargestEmptyCircle
oCgeos::algorithm::LengthFunctions for computing length
oCgeos::linearref::LengthIndexedLineSupports linear referencing along a linear geom::Geometry using the length along the line as the index
oCgeos::linearref::LengthIndexOfPointComputes the length index of the point on a linear Geometry nearest a given Coordinate
oCgeos::linearref::LengthLocationMapComputes the LinearLocation for a given length along a linear Geometry
oCgeos::linearref::LinearGeometryBuilderBuilds a linear geometry (LineString or MultiLineString) incrementally (point-by-point)
oCgeos::linearref::LinearIteratorAn iterator over the components and coordinates of a linear geometry (LineString or MultiLineString)
oCgeos::linearref::LinearLocationRepresents a location along a LineString or MultiLineString
oCgeos::operation::overlay::LineBuilderForms JTS LineStrings out of a the graph of geomgraph::DirectedEdge created by an OverlayOp
oCgeos::operation::overlayng::LineBuilder
oCgeos::algorithm::LineIntersectorA LineIntersector is an algorithm that can both test whether two line segments intersect and compute the intersection point if they do
oCgeos::operation::overlayng::LineLimiter
oCgeos::operation::linemerge::LineMergerSews together a set of fully noded LineStrings
oCgeos::geom::LineSegment
oCgeos::operation::linemerge::LineSequencerBuilds a sequence from a set of LineStrings so that they are ordered end to end
oCgeos::operation::overlay::snap::LineStringSnapperSnaps the vertices and segments of a LineString to a set of target snap vertices
oCgeos::linearref::LocationIndexedLineSupports linear referencing along a linear Geometry using LinearLocations as the index
oCgeos::linearref::LocationIndexOfLineDetermines the location of a subline along a linear Geometry
oCgeos::linearref::LocationIndexOfPointComputes the LinearLocation of the point on a linear Geometry nearest a given Coordinate
oCgeos::operation::valid::MakeValidThe function attempts to create a valid representation of a given invalid geometry without losing any of the input vertices
oCgeos::algorithm::construct::MaximumInscribedCircle
oCgeos::noding::snapround::MCIndexPointSnapper"Snaps" all SegmentStrings in a SpatialIndex containing MonotoneChains to a given HotPixel
oCgeos::precision::MinimumClearanceComputes the Minimum Clearance of a Geometry
oCgeos::algorithm::MinimumDiameterComputes the minimum diameter of a geom::Geometry
oCgeos::geomgraph::index::MonotoneChain
oCgeos::index::chain::MonotoneChainMonotone Chains are a way of partitioning the segments of a linestring to allow for fast searching of intersections
oCgeos::index::chain::MonotoneChainBuilderConstructs MonotoneChains for sequences of Coordinates
oCgeos::geomgraph::index::MonotoneChainEdgeMonotoneChains are a way of partitioning the segments of an edge to allow for fast searching of intersections
oCgeos::geomgraph::index::MonotoneChainIndexerMonotoneChains are a way of partitioning the segments of an edge to allow for fast searching of intersections
oCgeos::index::chain::MonotoneChainOverlapActionThe action for the internal iterator for performing overlap queries on a MonotoneChain
oCgeos::index::chain::MonotoneChainSelectAction
oCgeos::shape::fractal::MortonCode
oCgeos::index::bintree::NodeBaseThe base class for nodes in a Bintree
oCgeos::index::quadtree::NodeBaseThe base class for nodes in a Quadtree
oCgeos::planargraph::NodeMapA map of Node, indexed by the coordinate of the node
oCgeos::noding::NoderComputes all intersections between segments in a set of SegmentString
oCgeos::noding::NodingValidatorValidates that a collection of SegmentStrings is correctly noded. Throws a TopologyException if a noding error is found
oCgeos::noding::OctantMethods for computing and working with octants of the Cartesian plane
oCgeos::operation::buffer::OffsetCurveBuilderComputes the raw offset curve for a single Geometry component (ring, line or point)
oCgeos::operation::buffer::OffsetCurveSetBuilderCreates all the raw offset curves for a buffer of a Geometry
oCgeos::operation::overlay::validate::OffsetPointGeneratorGenerates points offset from both sides of all segments in a geometry
oCgeos::operation::buffer::OffsetSegmentGenerator
oCgeos::operation::buffer::OffsetSegmentString
oCgeos::algorithm::OrientationFunctions to compute the orientation of basic geometric structures including point triplets (triangles) and rings
oCgeos::noding::OrientedCoordinateArrayAllows comparing geom::CoordinateSequences in an orientation-independent way
oCgeos::operation::geounion::OverlapUnionUnions MultiPolygons efficiently by using full topological union only for polygons which may overlap by virtue of intersecting the common area of the inputs
oCgeos::operation::overlayng::OverlayGraph
oCgeos::operation::overlayng::OverlayLabel
oCgeos::operation::overlayng::OverlayMixedPoints
oCgeos::operation::overlayng::OverlayNG
oCgeos::operation::overlayng::OverlayNGRobust
oCgeos::operation::overlay::OverlayNodeFactoryCreates nodes for use in the geomgraph::PlanarGraph constructed during overlay operations. NOTE: also used by operation::valid
oCgeos::operation::overlayng::OverlayPoints
oCgeos::operation::overlay::validate::OverlayResultValidatorValidates that the result of an overlay operation is geometrically correct within a determined tolerance
oCgeos::operation::overlayng::OverlayUtil
oCgeos::geomgraph::PlanarGraphRepresents a directed graph which is embeddable in a planar surface
oCgeos::planargraph::PlanarGraphRepresents a directed graph which is embeddable in a planar surface
oCgeos::operation::overlay::PointBuilderConstructs geom::Point s from the nodes of an overlay graph
oCgeos::operation::geounion::PointGeometryUnionComputes the union of a puntal geometry with another arbitrary Geometry
oCgeos::algorithm::PointLocationFunctions for locating points within basic geometric structures such as lines and rings
oCgeos::algorithm::PointLocatorComputes the topological relationship (Location) of a single point to a Geometry
oCgeos::algorithm::locate::PointOnGeometryLocatorAn interface for classes which determine the Location of points in Polygon or MultiPolygon geometries
oCgeos::algorithm::distance::PointPairDistance
oCgeos::operation::overlay::PolygonBuilderForms Polygon out of a graph of geomgraph::DirectedEdge
oCgeos::operation::polygonize::PolygonizerPolygonizes a set of Geometrys which contain linework that represents the edges of a planar graph
oCgeos::geom::PositionA Position indicates the position of a Location relative to a graph component (Node, Edge, or Area)
oCgeos::geom::PrecisionModelSpecifies the precision model of the Coordinate in a Geometry
oCgeos::operation::overlayng::PrecisionReducer
oCgeos::operation::overlayng::PrecisionUtil
oCgeos::geom::prep::PreparedGeometryAn interface for classes which prepare Geometrys in order to optimize the performance of repeated calls to specific geometric operations
oCgeos::geom::prep::PreparedGeometryFactoryA factory for creating PreparedGeometrys
oCgeos::geom::prep::PreparedLineStringIntersectsComputes the intersects spatial relationship predicate for a target PreparedLineString relative to all other Geometry classes
oCgeos::geom::prep::PreparedPolygonPredicateA base class for predicate operations on PreparedPolygons
oCgeos::triangulate::quadedge::QuadEdgeA class that represents the edge data structure which implements the quadedge algebra
oCgeos::triangulate::quadedge::QuadEdgeLocatorAn interface for classes which locate an edge in a QuadEdgeSubdivision which either contains a given Vertex V or is an edge of a triangle which contains V
oCgeos::triangulate::quadedge::QuadEdgeSubdivisionA class that contains the QuadEdges representing a planar subdivision that models a triangulation
oCgeos::geom::QuadrantUtility functions for working with quadrants
oCgeos::operation::valid::QuadtreeNestedRingTesterTests whether any of a set of LinearRings are nested inside another ring in the set, using a Quadtree index to speed up the comparisons
oCgeos::algorithm::RayCrossingCounterCounts the number of segments crossed by a horizontal ray extending to the right from a given point, in an incremental fashion
oCgeos::algorithm::RayCrossingCounterDDCounts the number of segments crossed by a horizontal ray extending to the right from a given point, in an incremental fashion
oCgeos::operation::intersection::RectangleClipping rectangle
oCgeos::operation::predicate::RectangleContainsOptimized implementation of spatial predicate "contains" for cases where the first Geometry is a rectangle
oCgeos::operation::intersection::RectangleIntersectionSpeed-optimized clipping of a Geometry with a rectangle
oCgeos::operation::intersection::RectangleIntersectionBuilderRebuild geometries from subpaths left by clipping with a rectangle
oCgeos::operation::predicate::RectangleIntersectsOptimized implementation of the "intersects" spatial predicate for cases where one Geometry is a rectangle
oCgeos::operation::relate::RelateComputerComputes the topological relationship between two Geometries
oCgeos::operation::relate::RelateNodeFactoryUsed by the geomgraph::NodeMap in a RelateNodeGraph to create RelateNode objects
oCgeos::operation::relate::RelateNodeGraphImplements the simple graph of Nodes and geomgraph::EdgeEnd which is all that is required to determine topological relationships between Geometries
oCgeos::operation::valid::RepeatedPointRemoverRemoves repeated, consecutive equal, coordinates from a CoordinateSequence
oCgeos::operation::valid::RepeatedPointTesterImplements the appropriate checks for repeated points (consecutive identical coordinates) as defined in the JTS spec
oCgeos::operation::buffer::RightmostEdgeFinderA RightmostEdgeFinder find the geomgraph::DirectedEdge in a list which has the highest coordinate, and which is oriented L to R at that point. (I.e. the right side is on the RHS of the edge.)
oCgeos::operation::overlayng::RingClipper
oCgeos::operation::overlayng::RobustClipEnvelopeComputer
oCgeos::algorithm::RobustDeterminantImplements an algorithm to compute the sign of a 2x2 determinant for double precision values robustly
oCgeos::operation::predicate::SegmentIntersectionTesterTests if any line segments in two sets of CoordinateSequences intersect
oCgeos::noding::SegmentIntersectorProcesses possible intersections detected by a Noder
oCgeos::geomgraph::index::SegmentIntersectorComputes the intersection of line segments, and adds the intersection to the edges containing the segments
oCgeos::noding::SegmentNodeRepresents an intersection point between two NodedSegmentString
oCgeos::noding::SegmentNodeListA list of the SegmentNode present along a NodedSegmentString
oCgeos::noding::SegmentPointComparatorImplements a robust method of comparing the relative position of two points along the same segment
oCgeos::noding::SegmentSetMutualIntersectorAn intersector for the red-blue intersection problem
oCgeos::noding::SegmentStringAn interface for classes which represent a sequence of contiguous line segments
oCgeos::noding::SegmentStringUtilUtility methods for processing SegmentStrings
oCgeos::operation::sharedpaths::SharedPathsOpFind shared paths among two linear Geometry objects
oCgeos::geom::util::ShortCircuitedGeometryVisitorA visitor to Geometry elements which can be short-circuited by a given condition
oCgeos::precision::SimpleGeometryPrecisionReducerReduces the precision of a geom::Geometry according to the supplied geom::PrecisionModel, without attempting to preserve valid topology
oCgeos::operation::valid::SimpleNestedRingTesterTests whether any of a set of LinearRings are nested inside another ring in the set, using a simple O(n^2) comparison
oCgeos::operation::overlay::snap::SnapIfNeededOverlayOpPerforms an overlay operation using snapping and enhanced precision to improve the robustness of the result
oCgeos::operation::overlay::snap::SnapOverlayOpPerforms an overlay operation using snapping and enhanced precision to improve the robustness of the result
oCgeos::index::intervalrtree::SortedPackedIntervalRTreeA static index on a set of 1-dimensional intervals, using an R-Tree packed based on the order of the interval midpoints
oCgeos::index::SpatialIndexAbstract class defines basic insertion and query operations supported by classes implementing spatial index algorithms
oCgeos::planargraph::SubgraphA subgraph of a PlanarGraph
oCgeos::operation::buffer::SubgraphDepthLocaterLocates a subgraph inside a set of subgraphs, in order to determine the outside depth of the subgraph
oCgeos::index::sweepline::SweepLineIndexA sweepline implements a sorted index on a set of intervals
oCgeos::operation::valid::SweeplineNestedRingTesterTests whether any of a set of LinearRings are nested inside another ring in the set, using an SweepLineIndex to speed up the comparisons
oCgeos::simplify::TaggedLinesSimplifierSimplifies a collection of TaggedLineStrings, preserving topology (in the sense that no new intersections are introduced)
oCgeos::simplify::TaggedLineStringContains and owns a list of TaggedLineSegments
oCgeos::simplify::TaggedLineStringSimplifierSimplifies a TaggedLineString, preserving topology (in the sense that no new intersections are introduced). Uses the recursive Douglas-Peucker algorithm
oCgeos::geomgraph::TopologyLocationA TopologyLocation is the labelling of a GraphComponent's topological relationship to a single Geometry
oCgeos::simplify::TopologyPreservingSimplifierSimplifies a geometry, ensuring that the result is a valid geometry having the same dimension and number of components as the input
oCgeos::operation::valid::TopologyValidationErrorContains information about the nature and location of a geom::Geometry validation error
oCgeos::geom::TriangleRepresents a planar triangle, and provides methods for calculating various properties of triangles
oCgeos::geom::TrianglePredicateAlgorithms for computing values and predicates associated with triangles
oCgeos::triangulate::quadedge::TriangleVisitorAn interface for algorithms which process the triangles in a QuadEdgeSubdivision
oCgeos::operation::overlayng::UnaryUnionNG
oCgeos::operation::geounion::UnaryUnionOpUnions a collection of Geometry or a single Geometry (which may be a collection) together
oCgeos::operation::geounion::UnionStrategy
oCgeos::triangulate::quadedge::VertexModels a site (node) in a QuadEdgeSubdivision
oCgeos::triangulate::VoronoiDiagramBuilderA utility class which creates Voronoi Diagrams from collections of points
oCgeos::io::WKBReaderReads a Geometry from Well-Known Binary format
oCgeos::io::WKBWriterWrites a Geometry into Well-Known Binary format
oCgeos::io::WKTReaderWKT parser class; see also WKTWriter
\Cgeos::io::WKTWriterOutputs the textual representation of a Geometry. See also WKTReader