All Classes and Interfaces
Class
Description
A node of an
AbstractSTRtree
.A base class containing the logic for computes the contains
and covers spatial relationship predicates
for a
PreparedPolygon
relative to all other Geometry
classes.Base class for STRtree and SIRtree.
A test for intersection between two bounds, necessary because subclasses
of AbstractSTRtree have different implementations of bounds.
Locates all vertices in a geometry which are adjacent
to a given vertex.
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.
Functions for computing area.
Measures the degree of similarity between two
Geometry
s
using the area of intersection between the geometries.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.
A base for implementations of
GeometryFunction
which provides most
of the required structure.A base for implementations of
GeometryFunction
which provides most
of the required structure.Shows basic ways of creating and operating on geometries
A base class for
PreparedGeometry
subclasses.Represents a list of contiguous line segments,
and supports noding the segments.
An
BinTree
(or "Binary Interval Tree")
is a 1-dimensional version of a quadtree.A spatial object in an AbstractSTRtree.
A pair of
Boundable
s, whose leaf items
support a distance metric between them.The Class BoundablePairDistanceComparator.
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
.Builds the buffer geometry for a given input geometry and precision model.
Finds the approximate maximum distance from a buffer curve to
the originating 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.
A
ResultMatcher
which compares the results of
buffer operations for equality, up to the given tolerance.Validates that the result of a buffer operation
is geometrically correct, within a computed tolerance.
A connected subset of the graph of
DirectedEdge
s and Node
s.A
GeometryOperation
which validates the results of the
Geometry
buffer() method.An indicator that the app is performing a long operation.
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.
See Length, Area, Distance, Orientation, PointLocation
Basic computational geometry algorithms
for geometry and coordinates defined in 3-dimensional Cartesian space.
Implements basic computational geometry algorithms using
DD
arithmetic.Example of computing distance and closest points between geometries
using the DistanceOp class.
Utilities for processing
Collection
s.A class to parse Unix (and DOS/Win)-style application command-lines
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 single representative
Coordinate
from each connected component of a Geometry
.Locates the components of a Geometry
which lie in a target area.
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
.Checks that a
GeometryGraph
representing an area
(a Polygon
or MultiPolygon
)
has consistent semantics for area geometries.Tests whether the polygon rings in a
GeometryGraph
are consistent.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
Examples of constructing Geometries programmatically.
Computes the convex hull of a
Geometry
.Compares
Coordinate
s for their angle and distance
relative to an origin.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.Coordinate is the only leaf node now, but could be
refactored into a LeafNode class.
Reduces the precision of the
Coordinate
s in a
CoordinateSequence
to match the supplied PrecisionModel
.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
sStores an integer count, for use as a Map entry.
Implements extended-precision floating-point numbers
which maintain 106 bits (approximately 30 decimal digits) of precision.
Provides routines to simplify and localize debugging output.
Deprecated.
no longer used
Deprecated.
no longer used
A utility class which creates Delaunay Triangulations
from collections of points and extract the resulting
triangulation edges or triangles as geometries.
Deletes vertices within a selection box from a geometry component
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.
An algorithm for computing a distance metric
which is an approximation to the Hausdorff Distance
based on a discretization of the input
Geometry
.A graph containing
DissolveHalfEdge
s.A HalfEdge which carries information
required to support
LineDissolver
.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 linestring (sequence of points) using
the standard Douglas-Peucker algorithm.
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.Represents a ring of
PolygonizeDirectedEdge
s which form
a ring of a polygon.Compares EdgeRings based on their envelope,
using the standard lexicographic ordering.
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.A class that gives most of the functionality of DataInputStream, but is endian aware.
Provides versions of Geometry spatial functions which use
enhanced precision techniques to reduce the likelihood of robustness problems.
Example of using
EnhancedPrecisionOp
to avoid robustness problemsDefines a rectangular region of the 2D coordinate plane.
Tests whether it can be concluded that a rectangle intersects a geometry,
based on the relationship of the envelope(s) of the geometry.
A
ResultMatcher
which compares result for equality,
up to the given tolerance.Demonstrates how to implement a CoordinateSequence for a new kind of
coordinate (an
ExtendedCoordinate
in this example).Creates ExtendedCoordinateSequenceFactory internally represented
as an array of
ExtendedCoordinate
s.Extracts a component of a geometry to a new Test Case
Extracts the subline of a linear
Geometry
between
two LinearLocation
s on the line.Locates the paths to facets (vertices and segments) of
a
Geometry
which are within a given tolerance
of a query point.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.This class makes it easy to drag and drop files from the operating
system to a Java program.
Implement this inner interface to listen for when files are dropped.
Useful file utilities.
A GeometryFactory extension which fixes structurally bad coordinate sequences
used to create LinearRings.
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.
Deletes vertices or components from a geometry
which lie inside a given box.
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 visitor which tests whether it can be
concluded that a geometry contains a vertex of
a query geometry.
Holds the current
TestCaseEdit
.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.
Panel which displays rendered geometries.
Title:
Description:
Copyright: Copyright (c) 2001
Company:
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
.A reification of a function which can be executed on a
Geometry
, possibly with other arguments.A reification of a function which can be executed on a
Geometry
, possibly with other arguments.Invokes a function from registry
or a Geometry method determined by a named operation with a list of arguments,
the first of which is a
Geometry
.A registry to manage a collection of
GeometryFunction
s.A registry to manage a collection of
GeometryFunction
s.Implementations for various geometry functions.
A GeometryGraph is a graph that models a given Geometry
The base class for operations that require
GeometryGraph
s.Title:
Description:
Copyright: Copyright (c) 2001
Company:
An ItemDistance function for
items which are
Geometry
s,
using the Geometry.distance(Geometry)
method.Represents the location of a point on a Geometry.
Models 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 used for mapping.
An interface for classes which can determine whether
two geometries match, within a given tolerance.
Invokes a named operation on a set of arguments,
the first of which is a
Geometry
.Nodes the linework in a list of
Geometry
s using Snap-Rounding
to a given PrecisionModel
.Interface for classes which execute operations on
Geometry
s.Loads a GeometryOperation class
Finds a vertex or a point on a segment of a Geometry
which lies within a tolerance of a given point.
Reduces the precision of a
Geometry
according to the supplied PrecisionModel
,
ensuring that the result is topologically valid.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.
This set of strategies is not expected to be used directly outside of this distribution.
Cleans text strings which are supposed
to contain valid text for Geometries
(either WKB, WKB, or GML)
Various constant strings associated with GML format.
A SAX
DefaultHandler
which builds Geometry
s
from GML2-formatted geometries.This class is intended to log the SAX activity within a given element until its termination.
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.
Useful GUI utilities
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.
Implements a "hot pixel" as used in the Snap Rounding algorithm.
An object that creates an .html file describing the test cases.
Gets an icon from this class' package.
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.Tests whether the base geometry lies within
a specified distance of the given geometry.
Tests whether any of a set of
LinearRing
s are
nested inside another ring in the set, using a spatial
index to speed up the comparisons.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.
Finds an interior intersection in a set of
SegmentString
s,
if one exists.Finds interior intersections between line segments in
NodedSegmentString
s,
and adds them as nodes
using NodedSegmentString.addIntersection(LineIntersector, int, int, int)
.Computes a point in the interior of an areal geometry.
Finds a safe bisector Y ordinate
by projecting to the Y axis
and finding the Y-ordinate interval
which contains the centre of the Y extent.
Computes a point in the interior of an linear geometry.
Computes a point in the interior of an point geometry.
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.
Thrown when an attempt is made to load a shapefile
which contains an error such as an invlaid shape
Tests whether a
Geometry
is simple.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 an index.
Nodes a set of
NodedSegmentString
s completely.A Swing application which supports
creating geometries and running JTS operations.
The main frame for the JTS Test Builder.
An Exception which indicates a problem during reflection
A command-line utility to execute tests specified in JTS Test XML files.
JTS API version information.
A node of a
KdTree
, which represents one or more points in the same location.An implementation of a 2-D KD-Tree.
A Key is a unique identifier for a node in a tree.
A Key is a unique identifier for a node in a quadtree.
An example of using the
GMLHandler
class
to read geometry data out of KML files.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
.Locates
QuadEdge
s in a QuadEdgeSubdivision
,
optimizing the search by starting in the
locality of the last edge found.Experimental control panel for layers.
Functions for computing length.
Supports linear referencing along a linear
Geometry
using the length along the line as the index.Computes the length index of the point
on a linear
Geometry
nearest a given Coordinate
.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
.Examples of Linear Referencing
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
s
in which every unique segment appears once only.
Geometry
s
into a set of maximal-length
invalid reference
Linestring
A
LineIntersector
is an algorithm that can both test whether
two line segments intersect and compute the intersection point(s)
if they do.A
DirectedEdge
of a
LineMergeGraph
.An edge of a
LineMergeGraph
.Example of using the LineMerger class to sew together a set of fully noded
linestrings.
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.An spatial index on a set of
LineSegment
s.ItemVisitor subclass to reduce volume of query results.
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
.Shows a technique for identifying the location of self-intersections
in a non-simple LineString.
Snaps the vertices and segments of a
LineString
to a set of target snap vertices.MD - Probably obsolete
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.Determines the location of a subline along a linear
Geometry
.A
GeometryOperation
which logs
the input and output from another
GeometryOperation
.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.Uses Snap Rounding to compute a rounded,
fully noded arrangement from a set of
SegmentString
s.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
.Implements the MinimumClearance distance function:
dist(p1, p2) =
p1 != p2 : p1.distance(p2)
p1 == p2 : Double.MAX
dist(p, seg) =
p != seq.p1 invalid input: '&'invalid input: '&' p != seg.p2 : seg.distance(p)
ELSE : Double.MAX
Also computes the values of the nearest points, if any.
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
Reads a
Geometry
from a string which is in either WKT, WKBHex
or GML formatWrapper for a Shapefile arc.
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.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.A
ResultMatcher
which always passes.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 the raw offset curve for a
single
Geometry
component (ring, line or point).Creates all the raw offset curves for a buffer of a
Geometry
.Generates points offset by a given distance
from both sides of the midpoint of
all segments in a
Geometry
.Generates segments which form an offset curve.
A dynamic list of the vertices in a constructed offset curve.
The parameters for an instance of an option occurring in a command
Specifes the syntax for a single option on a
command line
ToDo:
- add syntax pattern parsing
Syntax patterns are similar to Java type signatures
F - float
I - int
L - long
S - string
B - boolean
+ - one or more
eg: "FIS+" takes a double, int, and one or more Strings
Functions to compute the orientation of basic geometric structures
including point triplets (triangles) and rings.
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.
Creates nodes for use in the
PlanarGraph
s constructed during
overlay operations.Computes the geometric overlay of two
Geometry
s.Validates that the result of an overlay operation is
geometrically correct, within a determined tolerance.
A
GeometryOperation
which validates the result of overlay operations.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.
Parameters passed to a main method (also known as "command-line arguments").
Thrown by a
WKTReader
when a parsing problem occurs.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.
Creates an .PNG file for a test case.
Represents a single point.
Constructs
Point
s from the nodes of an overlay graph.Wrapper for a Shapefile point.
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.
Extracts the LineStrings in the boundaries
of all the polygonal elements in the target
Geometry
.Forms
Polygon
s out of a graph of DirectedEdge
s.Wrapper for a Shapefile polygon.
A
DirectedEdge
of a PolygonizeGraph
, which represents
an edge of a polygon formed by the graph.An edge of a polygonization graph.
Example of using Polygonizer class to polygonize a set of fully noded linestrings
Represents a planar graph of edges that can be used to compute a
polygonization, and implements the algorithms to compute the
formed by the graph.
invalid reference
EdgeRings
Polygonizes a set of
Geometry
s which contain linework that
represents the edges of a planar graph.Adds every linear element in a
Geometry
into the polygonizer graph.A
Shape
which represents a polygon which may contain holes.Shows polygon structure (shells versus holes)
by symbolizing the rings differently.
Deprecated.
It is now recommended to use Geometry.union() (unary union) instead of this technique.
A Position indicates the position of a Location relative to a graph component
(Node, Edge, or Area).
Specifies the precision model of the
Coordinate
s in a Geometry
.The types of Precision Model which JTS supports.
An example showing the results of using different precision models
in computations involving geometric constructions.
An interface for classes which prepare
Geometry
s
in order to optimize the performance
of repeated calls to specific geometric operations.Shows use of
PreparedGeometry
in a batch (repeated) operation.A factory for creating
PreparedGeometry
s.Function to execute PreparedGeometry methods which have optimized behaviour.
A spatial index which indexes
PreparedGeometry
s
created from a set of Geometry
s.A
GeometryOperation
which uses PreparedGeometry
s
for applicable operations.A prepared version for
Lineal
geometries.Computes the intersects spatial relationship predicate
for a target
PreparedLineString
relative to other Geometry
classes.A prepared version for
Puntal
geometries.A prepared version for
Polygonal
geometries.Computes the contains spatial relationship predicate
for a
PreparedPolygon
relative to all other Geometry
classes.Computes the containsProperly spatial relationship predicate
for
PreparedPolygon
s relative to all other Geometry
classes.Computes the covers spatial relationship predicate
for a
PreparedPolygon
relative to all other Geometry
classes.Computes the intersects spatial relationship predicate for
PreparedPolygon
s relative to all other Geometry
classes.A base class for predicate operations on
PreparedPolygon
s.A priority queue over a set of
Comparable
objects.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.A TriangleVisitor which computes and sets the
circumcentre as the origin of the dual
edges originating in each triangle.
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, which are numbered as follows:
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.
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.A visitor to test for intersection between the query
rectangle and the line segments of the geometry.
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.A process object which renders a scene to a graphics context
and allows cancellation.
Implements the appropriate checks for repeated points
(consecutive identical coordinates) as defined in the
JTS spec.
An interface for classes which can determine whether
two
Result
s match, within a given tolerance.A RightmostEdgeFinder find the DirectedEdge in a list which has the highest coordinate,
and which is oriented L to R at that point.
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.Demonstrates use of
PreparedGeometry
s in a spatial index
to optimize spatial search.Models a constraint segment in a triangulation.
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.Thrown when an error relating to the shapefile
occures
Thrown when an attempt is made to load a shapefile
which contains a shape type that is not supported
by the loader
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.
An example showing a simple use of JTS methods for:
WKT reading
intersection
relate
WKT output
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.Uses Snap Rounding to compute a rounded,
fully noded arrangement from a set of
SegmentString
s.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.
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.
Implementations for various geometry functions.
A static index on a set of 1-dimensional intervals,
using an R-Tree packed based on the order of the interval midpoints.
Title:
Description:
Copyright: Copyright (c) 2001
Company:
Title:
Description:
Copyright: Copyright (c) 2001
Company:
The basic operations supported by classes
implementing spatial index algorithms.
Implementations for spatial predicate functions.
Models a constraint segment which can be split in two in various ways,
according to certain geometric constraints.
A
GeometryFunction
which calls a static
Method
.A
GeometryFunction
which calls a static
Method
.Implements a timer function which can compute
elapsed time as well as split times.
Models a vertex of a Geometry which will be stretched
due to being too near other segments and vertices.
Utility methods for working with
String
s.Useful string utilities
A query-only R-tree created using the Sort-Tile-Recursive (STR) algorithm.
Contains a list of styles and allows Geometrys
to be rendered using those styles.
A subgraph of a
PlanarGraph
.Locates a subgraph inside a set of subgraphs,
in order to determine the outside depth of the subgraph.
A segment from a directed edge which has been assigned a depth value
for its sides.
Writes the Well-Known Text representation of a
Geometry
.A sweepline implements a sorted index on a set of intervals.
An action taken when a
SweepLineIndex
detects that two
SweepLineInterval
s overlapThis is the 3rd version of SwingWorker (also known as
SwingWorker 3), an abstract class that you subclass to
perform GUI-related work in a dedicated thread.
Class to maintain reference to current worker thread
under separate synchronization control.
A
LineSegment
which is tagged with its location in a parent Geometry
.Simplifies a collection of TaggedLineStrings, preserving topology
(in the sense that no new intersections are introduced).
Represents a
LineString
which can be modified to a simplified shape.Simplifies a TaggedLineString, preserving topology
(in the sense that no new intersections are introduced).
A
GeometryOperation
which executes the original operation
and returns that result,
but also executes a separate operation (which could be multiple operations).A test for two geometries.
Encapsulates test case cursor logic.
A set of tests for two Geometry's.
Geometry functions which
augment the existing methods on
Geometry
,
for use in XML Test files.Geometry functions which
augment the existing methods on
Geometry
,
for use in XML Test files.Create the CoordinateSequenceFactory to be used in tests
Converts test File's to TestCase's and runs them.
Contains the Geometry objects which the JTS Test Builder
operates on
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.
A filter to add linear geometries to the linestring map
with the appropriate minimum size constraint.
Stretches the vertices and segments of a @link Geometry}
to make the topology more visible.
Executes tests specified in XML files.
Contains information about the nature and location of a
Geometry
validation errorInterface for classes which process triangles visited during traversals of a
QuadEdgeSubdivision
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
.Unions a
) together.
Collection
of Geometry
s or a single Geometry
(which may be a
invalid reference
GeoometryCollection
Experimental code to union MultiPolygons
with processing limited to the elements which actually interact.
A
CoordinateFilter
that builds a set of Coordinate
s.Title:
Description:
Copyright: Copyright (c) 2001
Company:
Title:
Description:
Copyright: Copyright (c) 2001
Company:
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
.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.Maintains the information associated with mapping
the model view to the screen
A utility class which creates Voronoi Diagrams
from collections of points.
Simplifies a linestring (sequence of points) using the
Visvalingam-Whyatt algorithm.
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.Reads a sequence of
Geometry
s in WKT format
from a text file.Reads a
Geometry
from a string which is in either WKT or WKBHex formatConverts a geometry in Well-Known Text format to a
Geometry
.Writes the Well-Known Text representation of a
Geometry
.