All Classes and Interfaces
Class
Description
A node of an
AbstractSTRtree
.Base class for STRtree and SIRtree.
Represents an affine transformation on the 2D Cartesian plane.
Builds an
AffineTransformation
defined by a set of control vectors.Supports creating
AffineTransformation
s defined by various kinds of
inputs and transformation mapping rules.Utility functions for working with angles.
Constructs an approximation to the medial axis of a Polygon,
as a set of linestrings representing the medial axis graph.
Functions for computing area.
Measures the degree of similarity between two
Geometry
s
using the area of intersection between the geometries.Builds an array of all visited items.
A utility for making programming assertions.
Thrown when the application is in an inconsistent state.
A CoordinateSequence wrapper which
projects 3D coordinates into one of the
three Cartesian axis planes,
using the standard orthonormal projection
(i.e.
Represents a read-only list of contiguous line segments.
An
BinTree
(or "Binary Interval Tree")
is a 1-dimensional version of a quadtree.A spatial object in an AbstractSTRtree.
The Class BoundablePairDistanceComparator.
A noder which extracts chains of boundary segments
as
SegmentString
s from a polygonal coverage.An 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.A
BoundaryNodeRule
which specifies that any points which are endpoints
of lineal components are in the boundary of the
parent geometry.A
BoundaryNodeRule
specifies that points are in the
boundary of a lineal geometry iff
the point lies on the boundary of an odd number
of components.A
BoundaryNodeRule
which determines that only
endpoints with valency of exactly 1 are on the boundary.A
BoundaryNodeRule
which determines that only
endpoints with valency greater than 1 are on the boundary.Computes the boundary of a
Geometry
.A noder which extracts boundary line segments
as
SegmentString
s.Finds the approximate maximum distance from a buffer curve to
the originating geometry.
Creates all the raw offset curves for a buffer of a
Geometry
.Validates that a given buffer curve lies an appropriate distance
from the input generating it.
Simplifies a buffer input line to
remove concavities with shallow depth.
Computes the buffer of a geometry, for both positive and negative buffer distances.
A value class containing the parameters which
specify how a buffer should be constructed.
Validates that the result of a buffer operation
is geometrically correct, within a computed tolerance.
Allows an array of bytes to be used as an
InStream
.Allows reading a stream of Java primitive datatypes from an underlying
InStream
,
with the representation being in either common byte ordering.Methods to read and write primitive Java datatypes from/to byte
sequences, allowing the byte order to be specified
Provides an efficient method of unioning a collection of
Polygonal
geometries.Computes the centroid of a
Geometry
of any dimension.Deprecated.
Basic computational geometry algorithms
for geometry and coordinates defined in 3-dimensional Cartesian space.
Implements basic computational geometry algorithms using
DD
arithmetic.Utilities for processing
Collection
s.Determines the maximum number of common most-significant
bits in the mantissa of one or numbers.
Provides versions of Geometry spatial functions which use
common bit removal to reduce the likelihood of robustness problems.
Removes common most-significant mantissa bits
from one or more
Geometry
s.Extracts a representative
Coordinate
from each connected component of a Geometry
.Constructs a concave hull of a set of points.
Constructs a concave hull of a set of polygons, respecting
the polygons as constraints.
A utility class which creates Conforming Delaunay Triangulations
from collections of points and linear constraints, and extract the resulting
triangulation edges or triangles as geometries.
Computes a Conforming Delaunay Triangulation over a set of sites and a set of
linear constraints.
A ConnectedElementPointFilter extracts a single point
from each connected element in a Geometry
(e.g.
Extracts a single point
from each connected element in a Geometry
(e.g.
Finds all connected
Subgraph
s of a PlanarGraph
.Tests whether the polygon rings in a
GeometryGraph
are consistent.Computes the Constrained Delaunay Triangulation of polygons.
Indicates a failure during constraint enforcement.
An interface for strategies for determining the location of split points on constraint segments.
A vertex in a Constrained Delaunay Triangulation.
An interface for factories which create a
ConstraintVertex
Computes the convex hull of a
Geometry
.A lightweight class used to store coordinates on the 2-dimensional Cartesian plane.
Compares two
Coordinate
s, allowing for either a 2-dimensional
or 3-dimensional comparison, and handling NaN values correctly.A
CoordinateFilter
that creates an array containing every
coordinate in a Geometry
.Useful utility functions for handling Coordinate arrays
A
Comparator
for Coordinate
arrays
modulo their directionality.A
Comparator
for Coordinate
arrays
in the forward direction of their coordinates,
using lexicographic ordering.A
CoordinateSequence
backed by an array of Coordinate
s.Creates
CoordinateSequence
s represented as an array of Coordinate
s.A
CoordinateFilter
that counts the total number of coordinates
in a Geometry
.An interface for classes which use the values of the coordinates in a
Geometry
.A list of
Coordinate
s, which may
be set to prevent repeated coordinates from occurring in the list.Reduces the precision of the
Coordinate
s in a
CoordinateSequence
to match the supplied PrecisionModel
.Useful utility functions for handling Coordinate objects.
The internal representation of a list of coordinates inside a Geometry.
Compares two
CoordinateSequence
s.A factory to create concrete instances of
CoordinateSequence
s.An interface for classes which process the coordinates in a
CoordinateSequence
.Utility functions for manipulating
CoordinateSequence
sCoordinate subclass supporting XY ordinates.
Coordinate subclass supporting XYM ordinates.
Coordinate subclass supporting XYZM ordinates.
Unions a valid coverage of polygons or lines
in an efficient way.
Creates a curved geometry by replacing the segments
of the input with Cubic Bezier Curves.
Implements extended-precision floating-point numbers
which maintain 106 bits (approximately 30 decimal digits) of precision.
Provides routines to simplify and localize debugging output.
A utility class which creates Delaunay Triangulations
from collections of points and extract the resulting
triangulation edges or triangles as geometries.
Densifies a
Geometry
by inserting extra vertices along the line segments
contained in the geometry.A Depth object records the topological depth of the sides
of an Edge for up to two Geometries.
Provides constants representing the dimensions of a point, a curve and a surface.
Represents a directed edge in a
PlanarGraph
.A DirectedEdgeStar is an ordered list of outgoing DirectedEdges around a node.
The Fréchet distance is a measure of similarity between curves.
An algorithm for computing a distance metric
which is an approximation to the Hausdorff Distance
based on a discretization of the input
Geometry
.A data structure that represents a partition of a set
into disjoint subsets, and allows merging subsets.
Functions to compute distance between basic geometric structures.
Find two points on two 3D
Geometry
s 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).Find two points on two
Geometry
s 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).Computes the Euclidean distance (L2 metric) from a
Coordinate
to a Geometry
.Computes the Euclidean distance (L2 metric) from a Point to a Geometry.
DoubleBits manipulates Double numbers
by using bit manipulation and bit-field extraction.
Simplifies a
Geometry
using the Douglas-Peucker algorithm.Represents an undirected edge of a
PlanarGraph
.A framework to visit sets of edge-connected
QuadEdgeTriangle
s in breadth-first orderModels the end of an edge incident on a node.
A collection of
EdgeEnd
s which obey the following invariant:
They originate at the same node and have the same direction.An ordered list of
EdgeEndBundle
s around a RelateNode
.A EdgeEndStar is an ordered list of EdgeEnds around a node.
A graph comprised of
HalfEdge
s.Builds an edge graph from geometries containing edges.
Represents a point on an
edge which intersects with another edge.
A list of edge intersections along an
Edge
.A EdgeList is a list of Edges.
Validates that a collection of
Edge
s is correctly noded.An EdgeSetIntersector computes all the intersections between the
edges in the set.
Nodes a set of edges.
A sequence of
LineMergeDirectedEdge
s forming one of the lines that will
be output by the line-merging process.Provides versions of Geometry spatial functions which use
enhanced precision techniques to reduce the likelihood of robustness problems.
Defines a rectangular region of the 2D coordinate plane.
Functions for computing distances between
Envelope
s.Represents a sequence of facets (points or line segments)
of a
Geometry
specified by a subsequence of a CoordinateSequence
.Validates that a collection of
SegmentString
s is correctly noded.Finds if two sets of
SegmentString
s intersect.Measures the degree of similarity between two
Geometry
s using the Fréchet distance metric.Finds the most likely
Location
of a point relative to
the polygonal components of a geometry, using a tolerance value.Constants for GeoJSON objects
Reads a GeoJSON Geometry from a JSON fragment into a
Geometry
.Writes
Geometry
s as JSON fragments in GeoJSON format.Computes various kinds of common geometric shapes.
A representation of a planar, linear vector geometry.
Models a collection of
Geometry
s of
arbitrary type and dimension.Maps the members of a
GeometryCollection
into another GeometryCollection via a defined
mapping function.Combines
Geometry
s
to produce a GeometryCollection
of the most appropriate type.Geometry
classes support the concept of applying
a GeometryComponentFilter
filter to the Geometry
.A class which supports creating new
Geometry
s
which are modifications of existing ones,
maintaining the same type structure.A
GeometryEditor.GeometryEditorOperation
which edits the coordinate list of a Geometry
.A interface which specifies an edit operation for Geometries.
A GeometryEditorOperation which does not modify
the input geometry.
A class which supports creating new
Geometry
s
which are modifications of existing ones,
maintaining the same type structure.A
GeometryEditorEx.GeometryEditorOperation
which edits the coordinate list of a Geometry
.A interface which specifies an edit operation for Geometries.
A GeometryEditorOperation which does not modify
the input geometry.
Extracts the components of a given type from a
Geometry
.Supplies a set of utility methods for building Geometry objects from lists
of Coordinates.
GeometryCollection
classes support the concept of
applying a GeometryFilter
to the Geometry
.Fixes a geometry to be a valid geometry, while preserving as much as
possible of the shape and location of the input.
A GeometryGraph is a graph that models a given Geometry
The base class for operations that require
GeometryGraph
s.An
ItemDistance
function for
items which are Geometry
s,
using the Geometry.distance(Geometry)
method.Represents the location of a point on a Geometry.
Methods to map various collections
of
Geometry
s
via defined mapping functions.An interface for geometry functions that map a geometry input to a geometry output.
Nodes the linework in a list of
Geometry
s using Snap-Rounding
to a given PrecisionModel
.Reduces the precision of a
Geometry
according to the supplied PrecisionModel
,
ensuring that the result is valid (unless specified otherwise).Snaps the vertices and segments of a
Geometry
to another Geometry's vertices.Container for GML2 Geometry parsing strategies which can be represented in JTS.
Various constant strings associated with GML format.
A SAX
DefaultHandler
which builds Geometry
s
from GML2-formatted geometries.Reads a GML2 geometry from an XML fragment into a
Geometry
.Writes
Geometry
s as XML fragments in GML2 format.A GraphComponent is the parent class for the objects'
that form a graph.
The base class for all graph component classes.
Represents a directed component of an edge in an
EdgeGraph
.Measures the degree of similarity between two
Geometry
s
using the Hausdorff distance metric.Represents a homogeneous coordinate in a 2-D coordinate space.
Encodes points as the index along finite planar Hilbert curves.
Generates a
LineString
representing the Hilbert Curve
at a given level.Assigns hole rings to shell rings
during polygonization.
Removes holes which match a given predicate.
Implements a "hot pixel" as used in the Snap Rounding algorithm.
A Hilbert-Packed R-tree.
Copies point ordinates with no transformation.
Computes a Delaunay Triangulation of a set of
Vertex
es, using an
incremental insertion algorithm.Computes the distance between the facets (segments and vertices)
of two
Geometry
s
using a Branch-and-Bound algorithm.Determines the
Location
of Coordinate
s relative to
an areal geometry, using indexing for efficiency.An adapter to allow an
InputStream
to be used as an InStream
A interface for classes providing an input stream of bytes.
An extendable array of primitive
int
values.Finds interior intersections between line segments in
NodedSegmentString
s,
and adds them as nodes
using NodedSegmentString.addIntersection(LineIntersector, int, int, int)
.Computes an interior point of a
Geometry
.Computes a point in the interior of an areal geometry.
Computes a point in the interior of an linear geometry.
Computes a point in the interior of an point geometry.
Functions to compute intersection points between lines and line segments.
Computes the possible intersections between two line segments in
NodedSegmentString
s
and adds them to each string
using NodedSegmentString.addIntersection(LineIntersector, int, int, int)
.Deprecated.
see InteriorIntersectionFinderAdder
Models a Dimensionally Extended Nine-Intersection Model (DE-9IM) matrix.
Represents an (1-dimensional) closed interval on the Real number line.
A contiguous portion of 1D-space.
Provides 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.
Removes holes which are invalid due to not being wholly covered by the parent shell.
Deprecated.
Replaced by org.locationtech.jts.operation.valid.IsSimpleOp
Tests whether a
Geometry
is simple as defined by the OGC SFS specification.Implements the algorithms required to compute the
isValid()
method
for Geometry
s.Boundable wrapper for a non-Boundable spatial object.
A function method which computes the distance
between two
ItemBoundable
s in an STRtree
.A visitor for items in a
SpatialIndex
.Nodes a set of
NodedSegmentString
s completely.JTS API version information.
A node of a
KdTree
, which represents one or more points in the same location.An implementation of a
KD-Tree
over two dimensions (X and Y).
A Key is a unique identifier for a node in a tree.
A Key is a unique identifier for a node in a quadtree.
Constructs a
Geometry
object from the OGC KML representation.Writes a formatted string containing the KML representation of a JTS
Geometry
.A
Label
indicates the topological relationship of a component
of a topology graph to a given Geometry
.Constructs the Largest Empty Circle for a set
of obstacle geometries, up to a specified tolerance.
Locates
QuadEdge
s in a QuadEdgeSubdivision
,
optimizing the search by starting in the
locality of the last edge found.Functions for computing length.
Supports linear referencing along a linear
Geometry
using the length along the line as the index.Computes the
LinearLocation
for a given length
along a linear Geometry
.Identifies
Geometry
subclasses which
are 1-dimensional and have components which are LineString
s.Extracts all the 1-dimensional (
LineString
) components from a Geometry
.Builds a linear geometry (
LineString
or MultiLineString
)
incrementally (point-by-point).An iterator over the components and coordinates of a linear geometry
(
LineString
s and MultiLineString
s.Represents a location along a
LineString
or MultiLineString
.Models an OGC SFS
LinearRing
.Forms JTS LineStrings out of a the graph of
DirectedEdge
s
created by an OverlayOp
.Dissolves the linear components
from a collection of
Geometry
s
into a set of maximal-length LineString
s
in which every unique segment appears once only.A
LineIntersector
is an algorithm that can both test whether
two line segments intersect and compute the intersection point(s)
if they do.Limits the segments in a list of segments
to those which intersect an envelope.
A
DirectedEdge
of a
LineMergeGraph
.An edge of a
LineMergeGraph
.A planar graph of edges that is analyzed to sew the edges together.
Merges a collection of linear components to form maximal-length linestrings.
Represents a line segment defined by two
Coordinate
s.Builds a sequence from a set of LineStrings so that
they are ordered end to end.
Models an OGC-style
LineString
.Extracts all the
LineString
elements from a Geometry
.Snaps the vertices and segments of a
LineString
to a set of target snap vertices.Constants representing the different topological locations
which can occur in a
Geometry
.Supports linear referencing
along a linear
Geometry
using LinearLocation
s as the index.A
HalfEdge
which supports
marking edges with a boolean flag.Various utility functions for mathematical and numerical operations.
Implements some 2D matrix operations
(in particular, solving systems of linear equations).
A ring of
DirectedEdge
s which may contain nodes of degree > 2.Constructs the Maximum Inscribed Circle for a
polygonal
Geometry
, up to a specified tolerance.Deprecated.
Not robust.
Utility functions to report JVM memory usage.
A simple split point finder which returns the midpoint of the split segment.
A ring of
Edge
s with the property that no node
has degree greater than 2.Computes the Minimum Bounding Circle (MBC)
for the points in a
Geometry
.Computes the Minimum Clearance of a
Geometry
.Computes the minimum diameter of a
Geometry
.Monotone Chains are a way of partitioning the segments of a linestring to
allow for fast searching of intersections.
Constructs
MonotoneChain
s
for sequences of Coordinate
s.MonotoneChains are a way of partitioning the segments of an edge to
allow for fast searching of intersections.
MonotoneChains are a way of partitioning the segments of an edge to
allow for fast searching of intersections.
The action for the internal iterator for performing
overlap queries on a MonotoneChain
The action for the internal iterator for performing
envelope select queries on a MonotoneChain
Encodes points as the index along the planar Morton (Z-order) curve.
Generates a
LineString
representing the Morton Curve
at a given level.Models a collection of
LineString
s.Models a collection of
Point
s.Models a collection of
Polygon
s.An interface for classes which support adding nodes to
a segment string.
A node of a
Bintree
.Represents a node of a
Quadtree
.A node in a
PlanarGraph
is a location where 0 or more Edge
s
meet.The base class for nodes in a
Bintree
.The base class for nodes in a
Quadtree
.Represents a list of contiguous line segments,
and supports noding the segments.
A map of nodes, indexed by the coordinate of the node
A map of
Node
s, indexed by the coordinate of the node.Computes all intersections between segments in a set of
SegmentString
s.Finds non-noded intersections in a set of
SegmentString
s,
if any exist.Validates that a collection of
SegmentString
s is correctly noded.A strategy for finding constraint split points which attempts to maximise the length of the split
segments while preventing further encroachment.
Indicates that an
AffineTransformation
is non-invertible.Indicates that a
HCoordinate
has been computed which is
not representable on the Cartesian plane.Counts occurrences of objects.
A bounding container for a
Geometry
which is in the shape of a general octagon.Methods for computing and working with octants of the Cartesian plane
Octants are numbered as follows:
Computes an offset curve from a geometry.
Computes the raw offset curve for a
single
Geometry
component (ring, line or point).Generates points offset by a given distance
from both sides of the midpoint of
all segments in a
Geometry
.An enumeration of possible Well-Known-Text or Well-Known-Binary ordinates.
Formats numeric values for ordinates
in a consistent, accurate way.
Functions to compute the orientation of basic geometric structures
including point triplets (triangles) and rings.
Utilities to modify the ring orientation of polygonal geometries.
Allows comparing
Coordinate
arrays
in an orientation-independent way.An adapter to allow an
OutputStream
to be used as an OutStream
A interface for classes providing an output stream of bytes.
Deprecated.
due to impairing performance
Computes the geometric overlay of two
Geometry
s,
using an explicit precision model to allow robust computation.Performs an overlay operation using
OverlayNG
,
providing full robustness by using a series of
increasingly robust (but slower) noding strategies.Creates nodes for use in the
PlanarGraph
s constructed during
overlay operations.Computes the geometric overlay of two
Geometry
s.Functions to test using spatial predicates
as a filter in front of overlay operations
to optimize performance.
Validates that the result of an overlay operation is
geometrically correct, within a determined tolerance.
A
CoordinateSequence
implementation based on a packed arrays.Packed coordinate sequence implementation based on doubles
Packed coordinate sequence implementation based on floats
Builds packed array coordinate sequences.
Thrown by a
WKTReader
when a parsing problem occurs.Unions a set of polygonal geometries by partitioning them
into connected sets of polygons.
The computation of the
IntersectionMatrix
relies on the use of a structure
called a "topology graph".Represents a directed graph which is embeddable in a planar surface.
Models a polygon lying in a plane in 3-dimensional Cartesian space.
Models a plane in 3-dimensional Cartesian space.
Represents a single point.
Constructs
Point
s from the nodes of an overlay graph.Functions for locating points within basic geometric
structures such as lines and rings.
Contains a pair of points and the distance between them.
Contains a pair of points and the distance between them.
An interface for classes which create
Shape
s to represent
PointShapeFactory.Point
geometries.Transforms a geometry
Coordinate
into a Java2D Point
,
possibly with a mathematical transformation of the ordinate values.Represents a polygon with linear edges, which may include holes.
Forms
Polygon
s out of a graph of DirectedEdge
s.Transforms a polygon with holes into a single self-touching (invalid) ring
by joining holes to the exterior shell or to another hole.
Computes topology-preserving simplified hulls of polygonal geometry.
Polygonizes a set of
Geometry
s which contain linework that
represents the edges of a planar graph.A
Shape
which represents a polygon which may contain holes.Computes a triangulation of each polygon in a
Geometry
.Indicates the position of a location relative to a
node or edge component of a planar topological structure.
Specifies the precision model of the
Coordinate
s in a Geometry
.The types of Precision Model which JTS supports.
Functions to reduce the precision of a geometry
by rounding it to a given precision model.
Functions for computing precision model scale factors
that ensure robust geometry operations.
An interface for classes which prepare
Geometry
s
in order to optimize the performance
of repeated calls to specific geometric operations.A factory for creating
PreparedGeometry
s.A prepared version for
Lineal
geometries.A prepared version for
Puntal
geometries.A prepared version for
Polygonal
geometries.Deprecated.
A class that represents the edge data structure which implements the quadedge algebra.
An 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.A class that contains the
QuadEdge
s representing a planar
subdivision that models a triangulation.Models a triangle formed from
QuadEdge
s in a QuadEdgeSubdivision
which forms a triangulation.Utilities for working with
QuadEdge
s.Utility functions for working with quadrants of the Euclidean plane.
A Quadtree is a spatial index structure for efficient range querying
of items bounded by 2D rectangles.
Creates random point sets contained in a
region defined by either a rectangular or a polygonal extent.
Creates random point sets
where the points are constrained to lie in the cells of a grid.
Counts the number of segments crossed by a horizontal ray extending to the right
from a given point, in an incremental fashion.
Clips polygonal geometry to a rectangle.
Optimized implementation of the contains spatial predicate
for cases where the first
Geometry
is a rectangle.Implementation of the intersects spatial predicate
optimized for the case where one
Geometry
is a rectangle.Computes whether a rectangle intersects line segments.
Computes the topological relationship between two Geometries.
Represents a node in the topological graph used to compute spatial relationships.
Implements the simple graph of Nodes and EdgeEnd which is all that is
required to determine topological relationships between Geometries.
Implements the SFS relate() generalized spatial predicate on two
Geometry
s.Implements the appropriate checks for repeated points
(consecutive identical coordinates) as defined in the
JTS spec.
Clips rings of points to a rectangle.
Implements an algorithm to compute the
sign of a 2x2 determinant for double precision values robustly.
A robust version of
LineIntersector
.The root node of a single
Bintree
.QuadRoot is the root of a single Quadtree.
Wraps a
Noder
and transforms its input
into the integer domain.Models a constraint segment in a triangulation.
A noder which extracts all line segments
as
SegmentString
s.Detects and records an intersection between two
SegmentString
s,
if one exists.Computes the intersection of line segments,
and adds the intersection to the edges containing the segments.
Processes possible intersections detected by a
Noder
.Represents an intersection point between two
SegmentString
s.A list of the
SegmentNode
s present along a noded SegmentString
.Implements a robust method of comparing the relative position of two
points along the same segment.
An intersector for the red-blue intersection problem.
An interface for classes which represent a sequence of contiguous line segments.
Dissolves a noded collection of
SegmentString
s to produce
a set of merged linework with unique segments.A merging strategy which can be used to update the context data of
SegmentString
s
which are merged during the dissolve process.Utility methods for processing
SegmentString
s.A
PathIterator
which provides paths for a collection of Shape
s.A visitor to
Geometry
components, which
allows short-circuiting when a defined condition holds.An interface for classes which measures the degree of similarity between two
Geometry
s.Provides methods to mathematically combine
SimilarityMeasure
values.Finds all intersections in one or two sets of edges,
using the straightforward method of
comparing all segments.
Deprecated.
use GeometryPrecisionReducer
Finds all intersections in one or two sets of edges,
using an x-axis sweepline algorithm in conjunction with Monotone Chains.
Computes the minimum clearance of a geometry or
set of geometries.
Nodes a set of
SegmentString
s by
performing a brute-force comparison of every segment to every other one.Intersects two sets of
SegmentString
s using
brute-force comparison.Finds all intersections in one or two sets of edges,
using a simple x-axis sweepline algorithm.
Creates geometries which are shaped like multi-armed stars
with each arm shaped like a sine wave.
Base class for
Noder
s which make a single
pass to find intersections.One-dimensional version of an STR-packed R-tree.
Removes holes which are smaller than a given area.
Performs an overlay operation using snapping and enhanced precision
to improve the robustness of the result.
Performs an overlay operation using snapping and enhanced precision
to improve the robustness of the result.
Finds intersections between line segments which are being snapped,
and adds them as nodes.
Nodes a set of segment strings
snapping vertices and intersection points together if
they lie within the given snap tolerance distance.
An index providing fast creation and lookup of snap points.
Finds intersections between line segments which will be snap-rounded,
and adds them as nodes to the segments.
Uses Snap Rounding to compute a rounded,
fully noded arrangement from a set of
SegmentString
s,
in a performant way, and avoiding unnecessary noding.A static index on a set of 1-dimensional intervals,
using an R-Tree packed based on the order of the interval midpoints.
Unions a set of polygonal geometries by partitioning them
into connected sets of polygons.
The basic operations supported by classes
implementing spatial index algorithms.
Computes a partition of a set of geometries into disjoint subsets,
based on a provided equivalence
SpatialPartition.EquivalenceRelation
.An interface for a function to compute an equivalence relation.
Models a constraint segment which can be split in two in various ways,
according to certain geometric constraints.
Implements a timer function which can compute
elapsed time as well as split times.
Utility methods for working with
String
s.A query-only R-tree created using the Sort-Tile-Recursive (STR) algorithm.
A subgraph of a
PlanarGraph
.A sweepline implements a sorted index on a set of intervals.
An action taken when a
SweepLineIndex
detects that two
SweepLineInterval
s overlapSimplifies a TaggedLineString, preserving topology
(in the sense that no new intersections are introduced).
A proxy to call TestBuilder functions dynamically.
Indicates an invalid or inconsistent topological situation encountered during processing
A TopologyLocation is the labelling of a
GraphComponent's topological relationship to a single Geometry.
Simplifies a geometry and ensures that
the result is a valid geometry having the
same dimension and number of components as the input,
and with the components having the same topological
relationship.
Contains information about the nature and location of a
Geometry
validation errorInterface for classes which process triangles visited during traversals of a
QuadEdgeSubdivision
A memory-efficient representation of a triangle in a triangulation.
Represents a planar triangle, and provides methods for calculating various
properties of triangles.
Algorithms for computing values and predicates
associated with triangles.
An interface for algorithms which process the triangles in a
QuadEdgeSubdivision
.Builds a triangulation from a set of
Tri
s
by populating the links to adjacent triangles.Reads a
Geometry
encoded into TWKB (Tiny Well-known Binary).Writes
Geometry
s in TWKB (Tiny Well-known Binary) format.Unions a geometry or collection of geometries in an
efficient way, using
OverlayNG
to ensure robust computation.Experimental code to union MultiPolygons
with processing limited to the elements which actually interact.
A strategy class that adapts UnaryUnion to different
kinds of overlay algorithms.
A
CoordinateFilter
that extracts a unique array of Coordinate
s.A wrapper for
Noder
s which validates
the output arrangement is correctly noded.Creates a buffer polygon with a varying buffer distance
at each vertex along a line.
A 2-dimensional mathematical vector represented by double-precision X and Y components.
Represents a vector in 3-dimensional Cartesian space.
Models a site (node) in a
QuadEdgeSubdivision
.A semi-static spatial index for points which occur
in a spatially-coherent sequence.
Creates a map between the vertex
Coordinate
s of a
set of Geometry
s,
and the parent geometry, and transfers the source geometry
data objects to geometry components tagged with the coordinates.A utility class which creates Voronoi Diagrams
from collections of points.
Simplifies a
Geometry
using the Visvalingam-Whyatt area-based algorithm.Constant values used by the WKB format
Reads a sequence of
Geometry
s in WKBHex format
from a text file.Reads a
Geometry
from a byte stream in Well-Known Binary format.Writes a
Geometry
into Well-Known Binary format.Constants used in the WKT (Well-Known Text) format.
Reads a sequence of
Geometry
s in WKT format
from a text file.Converts a geometry in Well-Known Text format to a
Geometry
.Writes the Well-Known Text representation of a
Geometry
.
Length
,Area
,Distance
,Orientation
,PointLocation