Package | Description |
---|---|
org.locationtech.jts.algorithm |
Contains classes and interfaces implementing fundamental computational geometry algorithms.
|
org.locationtech.jts.algorithm.distance |
Classes to compute distance metrics between geometries.
|
org.locationtech.jts.algorithm.locate |
Classes to determine the topological location of points in geometries.
|
org.locationtech.jts.algorithm.match |
Classes to compute matching metrics between geometries.
|
org.locationtech.jts.awt |
Classes to perform conversions from Java2D shape objects.
|
org.locationtech.jts.densify |
Classes to perform densification on geometries.
|
org.locationtech.jts.dissolve | |
org.locationtech.jts.edgegraph | |
org.locationtech.jts.geom |
Contains the
Geometry interface hierarchy and supporting classes. |
org.locationtech.jts.geom.prep |
Classes to perform optimized geometric operations on suitably prepared geometries.
|
org.locationtech.jts.geom.util |
Provides classes that parse and modify Geometry objects.
|
org.locationtech.jts.geomgraph |
Contains classes that implement topology graphs.
|
org.locationtech.jts.io |
Contains the interfaces for converting JTS objects to and from other formats.
|
org.locationtech.jts.io.gml2 |
Classes to read and write the GML2 geometry format.
|
org.locationtech.jts.io.kml | |
org.locationtech.jts.linearref |
Contains classes and interfaces implementing linear referencing on linear geometries
|
org.locationtech.jts.noding |
Classes to compute nodings for arrangements of line segments and line segment sequences.
|
org.locationtech.jts.operation |
Provides classes for implementing operations on geometries
|
org.locationtech.jts.operation.buffer |
Provides classes for computing buffers of geometries
|
org.locationtech.jts.operation.buffer.validate |
Classes to perform validation of the results of buffer operations.
|
org.locationtech.jts.operation.distance |
Provides classes for computing the distance between geometries
|
org.locationtech.jts.operation.distance3d | |
org.locationtech.jts.operation.linemerge |
Classes to perform line merging.
|
org.locationtech.jts.operation.overlay |
Contains classes that perform a topological overlay to compute boolean spatial functions.
|
org.locationtech.jts.operation.overlay.snap |
Classes to perform snapping on geometries to prepare them for overlay operations.
|
org.locationtech.jts.operation.overlay.validate |
Classes to validate the results of overlay operations.
|
org.locationtech.jts.operation.polygonize |
An API for polygonizing sets of lines.
|
org.locationtech.jts.operation.predicate |
Classes which implement topological predicates optimized for particular kinds of geometries.
|
org.locationtech.jts.operation.relate |
Contains classes to implement the computation of the spatial relationships of
Geometry s. |
org.locationtech.jts.operation.union |
Classes to perform efficient unioning of collections of geometries.
|
org.locationtech.jts.operation.valid |
Provides classes for testing the validity of geometries.
|
org.locationtech.jts.precision |
Provides classes for analyzing and
manipulating the precision of Geometries.
|
org.locationtech.jts.shape | |
org.locationtech.jts.shape.fractal | |
org.locationtech.jts.shape.random | |
org.locationtech.jts.simplify |
Classes which implement algorithms for simplifying or generalizing geometries.
|
org.locationtech.jts.triangulate |
Classes to compute Delaunay triangulations.
|
org.locationtech.jts.triangulate.quadedge |
Classes to implement a topological subdivision of quadeges, to support creating triangulations
and Voronoi diagrams.
|
org.locationtech.jts.util |
Contains support classes for the Java Topology Suite.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
MinimumBoundingCircle.getCircle()
Gets a geometry which represents the Minimum Bounding Circle.
|
Geometry |
ConvexHull.getConvexHull()
Returns a
Geometry that represents the convex hull of the input
geometry. |
Geometry |
MinimumBoundingCircle.getDiameter()
Gets a geometry representing the diameter of the computed Minimum Bounding
Circle.
|
Geometry |
MinimumBoundingCircle.getFarthestPoints()
Gets a geometry representing a line between the two farthest points
in the input.
|
static Geometry |
MinimumDiameter.getMinimumDiameter(Geometry geom)
Gets the length of the minimum diameter enclosing a geometry
|
Geometry |
MinimumDiameter.getMinimumRectangle()
Gets the minimum rectangular
Polygon which encloses the input geometry. |
static Geometry |
MinimumDiameter.getMinimumRectangle(Geometry geom)
Gets the minimum rectangle enclosing a geometry.
|
Modifier and Type | Method and Description |
---|---|
static Coordinate |
Centroid.getCentroid(Geometry geom)
Computes the centroid point of a geometry.
|
static Point |
InteriorPoint.getInteriorPoint(Geometry geom) |
static Coordinate |
InteriorPointLine.getInteriorPoint(Geometry geom)
Computes an interior point for the
linear components of a Geometry.
|
static Coordinate |
InteriorPointArea.getInteriorPoint(Geometry geom)
Computes an interior point for the
polygonal components of a Geometry.
|
static Coordinate |
InteriorPointPoint.getInteriorPoint(Geometry geom)
Computes an interior point for the
puntal components of a Geometry.
|
static Geometry |
MinimumDiameter.getMinimumDiameter(Geometry geom)
Gets the length of the minimum diameter enclosing a geometry
|
static Geometry |
MinimumDiameter.getMinimumRectangle(Geometry geom)
Gets the minimum rectangle enclosing a geometry.
|
boolean |
PointLocator.intersects(Coordinate p,
Geometry geom)
Convenience method to test a point for intersection with
a Geometry
|
int |
PointLocator.locate(Coordinate p,
Geometry geom)
Computes the topological relationship (
Location ) of a single point
to a Geometry. |
Constructor and Description |
---|
Centroid(Geometry geom)
Creates a new instance for computing the centroid of a geometry
|
ConvexHull(Geometry geometry)
Create a new convex hull construction for the input
Geometry . |
InteriorPointArea(Geometry g)
Creates a new interior point finder for an areal geometry.
|
InteriorPointLine(Geometry g) |
InteriorPointPoint(Geometry g) |
MinimumBoundingCircle(Geometry geom)
Creates a new object for computing the minimum bounding circle for the
point set defined by the vertices of the given geometry.
|
MinimumDiameter(Geometry inputGeom)
Compute a minimum diameter for a given
Geometry . |
MinimumDiameter(Geometry inputGeom,
boolean isConvex)
Compute a minimum diameter for a giver
Geometry ,
with a hint if
the Geometry is convex
(e.g. |
Modifier and Type | Method and Description |
---|---|
static void |
DistanceToPoint.computeDistance(Geometry geom,
Coordinate pt,
PointPairDistance ptDist) |
static double |
DiscreteHausdorffDistance.distance(Geometry g0,
Geometry g1) |
static double |
DiscreteHausdorffDistance.distance(Geometry g0,
Geometry g1,
double densifyFrac) |
Constructor and Description |
---|
DiscreteHausdorffDistance(Geometry g0,
Geometry g1) |
MaxDensifiedByFractionDistanceFilter(Geometry geom,
double fraction) |
MaxPointDistanceFilter(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
static boolean |
SimplePointInAreaLocator.isContained(Coordinate p,
Geometry geom)
Determines whether a point is contained in a
Geometry ,
or lies on its boundary. |
static int |
SimplePointInAreaLocator.locate(Coordinate p,
Geometry geom)
|
Constructor and Description |
---|
IndexedPointInAreaLocator(Geometry g)
Creates a new locator for a given
Geometry . |
SimplePointInAreaLocator(Geometry geom)
Create an instance of a point-in-area locator,
using the provided areal geometry.
|
Modifier and Type | Method and Description |
---|---|
double |
HausdorffSimilarityMeasure.measure(Geometry g1,
Geometry g2) |
double |
SimilarityMeasure.measure(Geometry g1,
Geometry g2)
Computes the similarity measure between two geometries
|
double |
AreaSimilarityMeasure.measure(Geometry g1,
Geometry g2) |
Modifier and Type | Method and Description |
---|---|
Geometry |
ShapeReader.read(PathIterator pathIt)
Converts a flat path to a
Geometry . |
static Geometry |
ShapeReader.read(PathIterator pathIt,
GeometryFactory geomFact)
Converts a flat path to a
Geometry . |
static Geometry |
ShapeReader.read(Shape shp,
double flatness,
GeometryFactory geomFact)
Converts a Shape to a Geometry, flattening it first.
|
static Geometry |
FontGlyphReader.read(String text,
Font font,
double flatness,
GeometryFactory geomFact)
|
static Geometry |
FontGlyphReader.read(String text,
Font font,
GeometryFactory geomFact)
|
static Geometry |
FontGlyphReader.read(String text,
String fontName,
int pointSize,
GeometryFactory geomFact)
Converts text rendered in the given font and pointsize to a
Geometry
using a standard flatness factor. |
Modifier and Type | Method and Description |
---|---|
Shape |
ShapeWriter.toShape(Geometry geometry)
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
Densifier.densify(Geometry geom,
double distanceTolerance)
Densifies a geometry using a given distance tolerance,
and respecting the input geometry's
PrecisionModel . |
Geometry |
Densifier.getResultGeometry()
Gets the densified geometry.
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
Densifier.densify(Geometry geom,
double distanceTolerance)
Densifies a geometry using a given distance tolerance,
and respecting the input geometry's
PrecisionModel . |
Constructor and Description |
---|
Densifier(Geometry inputGeom)
Creates a new densifier instance.
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
LineDissolver.dissolve(Geometry g)
Dissolves the linear components in a geometry.
|
Geometry |
LineDissolver.getResult()
Gets the dissolved result as a MultiLineString.
|
Modifier and Type | Method and Description |
---|---|
void |
LineDissolver.add(Geometry geometry)
Adds a
Geometry to be dissolved. |
static Geometry |
LineDissolver.dissolve(Geometry g)
Dissolves the linear components in a geometry.
|
Modifier and Type | Method and Description |
---|---|
void |
EdgeGraphBuilder.add(Geometry geometry)
Adds the edges of a Geometry to the graph.
|
Modifier and Type | Class and Description |
---|---|
class |
GeometryCollection
Models a collection of
Geometry s of
arbitrary type and dimension. |
class |
LinearRing
Models an OGC SFS
LinearRing . |
class |
LineString
Models an OGC-style
LineString . |
class |
MultiLineString
Models a collection of
LineString s. |
class |
MultiPoint
Models a collection of
Point s. |
class |
MultiPolygon
Models a collection of
Polygon s. |
class |
Point
Represents a single point.
|
class |
Polygon
Represents a polygon with linear edges, which may include holes.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
Geometry.buffer(double distance)
Computes a buffer area around this geometry having the given width.
|
Geometry |
Geometry.buffer(double distance,
int quadrantSegments)
Computes a buffer area around this geometry having the given width and with
a specified accuracy of approximation for circular arcs.
|
Geometry |
Geometry.buffer(double distance,
int quadrantSegments,
int endCapStyle)
Computes a buffer area around this geometry having the given
width and with a specified accuracy of approximation for circular arcs,
and using a specified end cap style.
|
Geometry |
GeometryFactory.buildGeometry(Collection geomList)
Build an appropriate
Geometry , MultiGeometry , or
GeometryCollection to contain the Geometry s in
it. |
Geometry |
Geometry.convexHull()
Computes the smallest convex
Polygon that contains all the
points in the Geometry . |
Geometry |
Polygon.convexHull() |
Geometry |
Geometry.copy()
Creates a deep copy of this
Geometry object. |
Geometry |
GeometryFactory.createGeometry(Geometry g)
Creates a deep copy of the input
Geometry . |
Geometry |
Geometry.difference(Geometry other)
Computes a
Geometry representing the closure of the point-set
of the points contained in this Geometry that are not contained in
the other Geometry. |
abstract Geometry |
Geometry.getBoundary()
Returns the boundary, or an empty geometry of appropriate dimension
if this
Geometry is empty. |
Geometry |
LineString.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
MultiPolygon.getBoundary()
Computes the boundary of this geometry
|
Geometry |
MultiLineString.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
GeometryCollection.getBoundary() |
Geometry |
Point.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
MultiPoint.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
Polygon.getBoundary()
Computes the boundary of this geometry
|
Geometry |
Geometry.getEnvelope()
Gets a Geometry representing the envelope (bounding box) of
this
Geometry . |
Geometry |
Geometry.getGeometryN(int n)
Returns an element
Geometry from a GeometryCollection
(or this , if the geometry is not a collection). |
Geometry |
GeometryCollection.getGeometryN(int n) |
Geometry |
Geometry.intersection(Geometry other)
Computes a
Geometry representing the point-set which is
common to both this Geometry and the other Geometry. |
Geometry |
Geometry.norm()
Creates a new Geometry which is a normalized
copy of this Geometry.
|
static Geometry |
OctagonalEnvelope.octagonalEnvelope(Geometry geom)
Gets the octagonal envelope of a geometry
|
abstract Geometry |
Geometry.reverse()
Computes a new geometry which has all component coordinate sequences
in reverse order (opposite orientation) to this one.
|
Geometry |
LinearRing.reverse() |
Geometry |
LineString.reverse()
Creates a
LineString whose coordinates are in the reverse
order of this objects |
Geometry |
MultiPolygon.reverse()
Creates a
MultiPolygon with
every component reversed. |
Geometry |
MultiLineString.reverse()
Creates a
MultiLineString in the reverse
order to this object. |
Geometry |
GeometryCollection.reverse()
Creates a
GeometryCollection with
every component reversed. |
Geometry |
Point.reverse() |
Geometry |
Polygon.reverse() |
Geometry |
Geometry.symDifference(Geometry other)
Computes a
Geometry representing the closure of the point-set
which is the union of the points in this Geometry which are not
contained in the other Geometry,
with the points in the other Geometry not contained in this
Geometry . |
Geometry |
GeometryFactory.toGeometry(Envelope envelope)
Creates a
Geometry with the same extent as the given envelope. |
Geometry |
OctagonalEnvelope.toGeometry(GeometryFactory geomFactory) |
static Geometry[] |
GeometryFactory.toGeometryArray(Collection geometries)
Converts the
List to an array. |
Geometry |
Geometry.union()
Computes the union of all the elements of this geometry.
|
Geometry |
Geometry.union(Geometry other)
Computes a
Geometry representing the point-set
which is contained in both this
Geometry and the other Geometry. |
Modifier and Type | Method and Description |
---|---|
boolean |
Geometry.contains(Geometry g)
Tests whether this geometry contains the
argument geometry.
|
boolean |
Geometry.coveredBy(Geometry g)
Tests whether this geometry is covered by the
argument geometry.
|
boolean |
Geometry.covers(Geometry g)
Tests whether this geometry covers the
argument geometry.
|
Geometry |
GeometryFactory.createGeometry(Geometry g)
Creates a deep copy of the input
Geometry . |
GeometryCollection |
GeometryFactory.createGeometryCollection(Geometry[] geometries)
Creates a GeometryCollection using the given Geometries; a null or empty
array will create an empty GeometryCollection.
|
static Point |
GeometryFactory.createPointFromInternalCoord(Coordinate coord,
Geometry exemplar) |
boolean |
Geometry.crosses(Geometry g)
Tests whether this geometry crosses the
argument geometry.
|
Geometry |
Geometry.difference(Geometry other)
Computes a
Geometry representing the closure of the point-set
of the points contained in this Geometry that are not contained in
the other Geometry. |
boolean |
Geometry.disjoint(Geometry g)
Tests whether this geometry is disjoint from the argument geometry.
|
double |
Geometry.distance(Geometry g)
Returns the minimum distance between this
Geometry
and another Geometry . |
boolean |
Geometry.equals(Geometry g)
Tests whether this geometry is
topologically equal to the argument geometry.
|
boolean |
Geometry.equalsExact(Geometry other)
Returns true if the two
Geometry s are exactly equal. |
abstract boolean |
Geometry.equalsExact(Geometry other,
double tolerance)
Returns true if the two
Geometry s are exactly equal,
up to a specified distance tolerance. |
boolean |
LineString.equalsExact(Geometry other,
double tolerance) |
boolean |
MultiPolygon.equalsExact(Geometry other,
double tolerance) |
boolean |
MultiLineString.equalsExact(Geometry other,
double tolerance) |
boolean |
GeometryCollection.equalsExact(Geometry other,
double tolerance) |
boolean |
Point.equalsExact(Geometry other,
double tolerance) |
boolean |
MultiPoint.equalsExact(Geometry other,
double tolerance) |
boolean |
Polygon.equalsExact(Geometry other,
double tolerance) |
boolean |
Geometry.equalsNorm(Geometry g)
Tests whether two geometries are exactly equal
in their normalized forms.
|
boolean |
Geometry.equalsTopo(Geometry g)
Tests whether this geometry is topologically equal to the argument geometry
as defined by the SFS
equals predicate. |
void |
OctagonalEnvelope.expandToInclude(Geometry g) |
void |
GeometryFilter.filter(Geometry geom)
Performs an operation with or on
geom . |
void |
GeometryComponentFilter.filter(Geometry geom)
Performs an operation with or on
geom . |
Geometry |
Geometry.intersection(Geometry other)
Computes a
Geometry representing the point-set which is
common to both this Geometry and the other Geometry. |
boolean |
Geometry.intersects(Geometry g)
Tests whether this geometry intersects the argument geometry.
|
boolean |
Geometry.isWithinDistance(Geometry geom,
double distance)
Tests whether the distance from this
Geometry
to another is less than or equal to a specified value. |
static Geometry |
OctagonalEnvelope.octagonalEnvelope(Geometry geom)
Gets the octagonal envelope of a geometry
|
boolean |
Geometry.overlaps(Geometry g)
Tests whether this geometry overlaps the
specified geometry.
|
IntersectionMatrix |
Geometry.relate(Geometry g)
Returns the DE-9IM
IntersectionMatrix for the two Geometry s. |
boolean |
Geometry.relate(Geometry g,
String intersectionPattern)
Tests whether the elements in the DE-9IM
IntersectionMatrix for the two Geometry s match the elements in intersectionPattern . |
Geometry |
Geometry.symDifference(Geometry other)
Computes a
Geometry representing the closure of the point-set
which is the union of the points in this Geometry which are not
contained in the other Geometry,
with the points in the other Geometry not contained in this
Geometry . |
boolean |
Geometry.touches(Geometry g)
Tests whether this geometry touches the
argument geometry.
|
Geometry |
Geometry.union(Geometry other)
Computes a
Geometry representing the point-set
which is contained in both this
Geometry and the other Geometry. |
boolean |
Geometry.within(Geometry g)
Tests whether this geometry is within the
specified geometry.
|
Constructor and Description |
---|
GeometryCollection(Geometry[] geometries,
GeometryFactory factory) |
GeometryCollection(Geometry[] geometries,
PrecisionModel precisionModel,
int SRID)
Deprecated.
Use GeometryFactory instead
|
GeometryCollectionIterator(Geometry parent)
Constructs an iterator over the given
Geometry . |
OctagonalEnvelope(Geometry geom)
Creates a new null bounding octagon bounding a
Geometry |
Modifier and Type | Method and Description |
---|---|
Geometry |
PreparedGeometry.getGeometry()
Gets the original
Geometry which has been prepared. |
Modifier and Type | Method and Description |
---|---|
boolean |
PreparedPolygon.contains(Geometry g) |
boolean |
PreparedGeometry.contains(Geometry geom)
Tests whether the base
Geometry contains a given geometry. |
boolean |
PreparedPolygon.containsProperly(Geometry g) |
boolean |
PreparedGeometry.containsProperly(Geometry geom)
Tests whether the base
Geometry properly contains a given geometry. |
boolean |
PreparedGeometry.coveredBy(Geometry geom)
Tests whether the base
Geometry is covered by a given geometry. |
boolean |
PreparedPolygon.covers(Geometry g) |
boolean |
PreparedGeometry.covers(Geometry geom)
Tests whether the base
Geometry covers a given geometry. |
PreparedGeometry |
PreparedGeometryFactory.create(Geometry geom)
Creates a new
PreparedGeometry appropriate for the argument Geometry . |
boolean |
PreparedGeometry.crosses(Geometry geom)
Tests whether the base
Geometry crosses a given geometry. |
boolean |
PreparedGeometry.disjoint(Geometry geom)
Tests whether the base
Geometry is disjoint from a given geometry. |
boolean |
PreparedPoint.intersects(Geometry g)
Tests whether this point intersects a
Geometry . |
boolean |
PreparedPolygon.intersects(Geometry g) |
boolean |
PreparedLineString.intersects(Geometry g) |
boolean |
PreparedGeometry.intersects(Geometry geom)
Tests whether the base
Geometry intersects a given geometry. |
boolean |
PreparedGeometry.overlaps(Geometry geom)
Tests whether the base
Geometry overlaps a given geometry. |
static PreparedGeometry |
PreparedGeometryFactory.prepare(Geometry geom)
Creates a new
PreparedGeometry appropriate for the argument Geometry . |
boolean |
PreparedGeometry.touches(Geometry geom)
Tests whether the base
Geometry touches a given geometry. |
boolean |
PreparedGeometry.within(Geometry geom)
Tests whether the base
Geometry is within a given geometry. |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryCombiner.combine()
Computes the combination of the input geometries
to produce the most appropriate
Geometry or GeometryCollection |
static Geometry |
GeometryCombiner.combine(Collection geoms)
Combines a collection of geometries.
|
static Geometry |
GeometryCombiner.combine(Geometry g0,
Geometry g1)
Combines two geometries.
|
static Geometry |
GeometryCombiner.combine(Geometry g0,
Geometry g1,
Geometry g2)
Combines three geometries.
|
static Geometry |
SineStarFactory.create(Coordinate origin,
double size,
int nPts,
int nArms,
double armLengthRatio)
Creates a sine star with the given parameters.
|
Geometry |
SineStarFactory.createSineStar()
Generates the geometry for the sine star
|
Geometry |
GeometryEditor.edit(Geometry geometry,
GeometryEditor.GeometryEditorOperation operation)
Edit the input
Geometry with the given edit operation. |
Geometry |
GeometryEditor.GeometryEditorOperation.edit(Geometry geometry,
GeometryFactory factory)
Edits a Geometry by returning a new Geometry with a modification.
|
Geometry |
GeometryEditor.NoOpGeometryOperation.edit(Geometry geometry,
GeometryFactory factory) |
Geometry |
GeometryEditor.CoordinateOperation.edit(Geometry geometry,
GeometryFactory factory) |
Geometry |
GeometryEditor.CoordinateSequenceOperation.edit(Geometry geometry,
GeometryFactory factory) |
static Geometry |
LinearComponentExtracter.getGeometry(Geometry geom)
Extracts the linear components from a single
Geometry
and returns them as either a LineString or MultiLineString . |
static Geometry |
LineStringExtracter.getGeometry(Geometry geom)
Extracts the
LineString elements from a single Geometry
and returns them as either a LineString or MultiLineString . |
static Geometry |
LinearComponentExtracter.getGeometry(Geometry geom,
boolean forceToLineString)
Extracts the linear components from a single
Geometry
and returns them as either a LineString or MultiLineString . |
Geometry |
GeometryTransformer.getInputGeometry()
Utility function to make input geometry available
|
Geometry |
GeometryMapper.MapOp.map(Geometry g)
Computes a new geometry value.
|
static Geometry |
GeometryMapper.map(Geometry geom,
GeometryMapper.MapOp op)
Maps the members of a
Geometry
(which may be atomic or composite)
into another Geometry of most specific type. |
Geometry |
GeometryTransformer.transform(Geometry inputGeom) |
Geometry |
AffineTransformation.transform(Geometry g)
Creates a new
Geometry which is the result
of this transformation applied to the input Geometry. |
Modifier and Type | Method and Description |
---|---|
void |
ShortCircuitedGeometryVisitor.applyTo(Geometry geom) |
static Geometry |
GeometryCombiner.combine(Geometry g0,
Geometry g1)
Combines two geometries.
|
static Geometry |
GeometryCombiner.combine(Geometry g0,
Geometry g1,
Geometry g2)
Combines three geometries.
|
abstract Coordinate[] |
GeometryEditor.CoordinateOperation.edit(Coordinate[] coordinates,
Geometry geometry)
Edits the array of
Coordinate s from a Geometry . |
abstract CoordinateSequence |
GeometryEditor.CoordinateSequenceOperation.edit(CoordinateSequence coordSeq,
Geometry geometry)
Edits a
CoordinateSequence from a Geometry . |
Geometry |
GeometryEditor.edit(Geometry geometry,
GeometryEditor.GeometryEditorOperation operation)
Edit the input
Geometry with the given edit operation. |
Geometry |
GeometryEditor.GeometryEditorOperation.edit(Geometry geometry,
GeometryFactory factory)
Edits a Geometry by returning a new Geometry with a modification.
|
Geometry |
GeometryEditor.NoOpGeometryOperation.edit(Geometry geometry,
GeometryFactory factory) |
Geometry |
GeometryEditor.CoordinateOperation.edit(Geometry geometry,
GeometryFactory factory) |
Geometry |
GeometryEditor.CoordinateSequenceOperation.edit(Geometry geometry,
GeometryFactory factory) |
static List |
GeometryExtracter.extract(Geometry geom,
Class clz)
|
static List |
GeometryExtracter.extract(Geometry geom,
Class clz,
List list)
|
void |
PointExtracter.filter(Geometry geom) |
void |
LinearComponentExtracter.filter(Geometry geom) |
void |
ComponentCoordinateExtracter.filter(Geometry geom) |
void |
GeometryExtracter.filter(Geometry geom) |
void |
LineStringExtracter.filter(Geometry geom) |
void |
PolygonExtracter.filter(Geometry geom) |
static List |
ComponentCoordinateExtracter.getCoordinates(Geometry geom)
Extracts the linear components from a single geometry.
|
static Geometry |
LinearComponentExtracter.getGeometry(Geometry geom)
Extracts the linear components from a single
Geometry
and returns them as either a LineString or MultiLineString . |
static Geometry |
LineStringExtracter.getGeometry(Geometry geom)
Extracts the
LineString elements from a single Geometry
and returns them as either a LineString or MultiLineString . |
static Geometry |
LinearComponentExtracter.getGeometry(Geometry geom,
boolean forceToLineString)
Extracts the linear components from a single
Geometry
and returns them as either a LineString or MultiLineString . |
static List |
LinearComponentExtracter.getLines(Geometry geom)
Extracts the linear components from a single geometry.
|
static List |
LineStringExtracter.getLines(Geometry geom)
|
static List |
LinearComponentExtracter.getLines(Geometry geom,
boolean forceToLineString)
Extracts the linear components from a single geometry.
|
static Collection |
LinearComponentExtracter.getLines(Geometry geom,
Collection lines)
Extracts the linear components from a single
Geometry
and adds them to the provided Collection . |
static Collection |
LinearComponentExtracter.getLines(Geometry geom,
Collection lines,
boolean forceToLineString)
Extracts the linear components from a single
Geometry
and adds them to the provided Collection . |
static List |
LineStringExtracter.getLines(Geometry geom,
List lines)
|
static List |
PointExtracter.getPoints(Geometry geom)
|
static List |
PointExtracter.getPoints(Geometry geom,
List list)
|
static List |
PolygonExtracter.getPolygons(Geometry geom)
|
static List |
PolygonExtracter.getPolygons(Geometry geom,
List list)
|
Geometry |
GeometryMapper.MapOp.map(Geometry g)
Computes a new geometry value.
|
static Geometry |
GeometryMapper.map(Geometry geom,
GeometryMapper.MapOp op)
Maps the members of a
Geometry
(which may be atomic or composite)
into another Geometry of most specific type. |
Geometry |
GeometryTransformer.transform(Geometry inputGeom) |
Geometry |
AffineTransformation.transform(Geometry g)
Creates a new
Geometry which is the result
of this transformation applied to the input Geometry. |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryGraph.getGeometry() |
Constructor and Description |
---|
GeometryGraph(int argIndex,
Geometry parentGeom) |
GeometryGraph(int argIndex,
Geometry parentGeom,
BoundaryNodeRule boundaryNodeRule) |
Modifier and Type | Method and Description |
---|---|
Geometry |
WKBReader.read(byte[] bytes)
Reads a single
Geometry in WKB format from a byte array. |
Geometry |
WKBReader.read(InStream is)
|
Geometry |
WKTReader.read(Reader reader)
|
Geometry |
WKTReader.read(String wellKnownText)
|
Modifier and Type | Method and Description |
---|---|
byte[] |
WKBWriter.write(Geometry geom)
Writes a
Geometry into a byte array. |
String |
WKTWriter.write(Geometry geometry)
Converts a
Geometry to its Well-known Text representation. |
void |
WKBWriter.write(Geometry geom,
OutStream os)
|
void |
WKTWriter.write(Geometry geometry,
Writer writer)
Converts a
Geometry to its Well-known Text representation. |
String |
WKTWriter.writeFormatted(Geometry geometry)
Same as
write , but with newlines and spaces to make the
well-known text more readable. |
void |
WKTWriter.writeFormatted(Geometry geometry,
Writer writer)
Same as
write , but with newlines and spaces to make the
well-known text more readable. |
Modifier and Type | Method and Description |
---|---|
Geometry |
GMLHandler.getGeometry()
Gets the geometry parsed by this handler.
|
Geometry |
GMLReader.read(Reader reader,
GeometryFactory geometryFactory)
Reads a GML2 Geometry from a
Reader into a single Geometry
If a collection of Geometries is found, a GeometryCollection is returned. |
Geometry |
GMLReader.read(String gml,
GeometryFactory geometryFactory)
Reads a GML2 Geometry from a String into a single
Geometry
If a collection of geometries is found, a GeometryCollection is returned. |
Modifier and Type | Method and Description |
---|---|
String |
GMLWriter.write(Geometry geom)
Writes a
Geometry in GML2 format to a String. |
void |
GMLWriter.write(Geometry geom,
Writer writer)
|
Modifier and Type | Method and Description |
---|---|
String |
KMLWriter.write(Geometry geom)
Writes a
Geometry in KML format as a string. |
void |
KMLWriter.write(Geometry geometry,
StringBuffer buf)
Appends the KML representation of a
Geometry to a StringBuffer . |
void |
KMLWriter.write(Geometry geometry,
Writer writer)
|
static String |
KMLWriter.writeGeometry(Geometry geometry,
double z)
Writes a Geometry as KML to a string, using
a specified Z value.
|
static String |
KMLWriter.writeGeometry(Geometry geometry,
double z,
int precision,
boolean extrude,
String altitudeMode)
Writes a Geometry as KML to a string, using
a specified Z value, precision, extrude flag,
and altitude mode code.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
LengthIndexedLine.extractLine(double startIndex,
double endIndex)
Computes the
LineString for the interval
on the line between the given indices. |
Geometry |
LocationIndexedLine.extractLine(LinearLocation startIndex,
LinearLocation endIndex)
Computes the
LineString for the interval
on the line between the given indices. |
Geometry |
LinearGeometryBuilder.getGeometry() |
Modifier and Type | Method and Description |
---|---|
void |
LinearLocation.clamp(Geometry linear)
Ensures the indexes are valid for a given linear
Geometry . |
Coordinate |
LinearLocation.getCoordinate(Geometry linearGeom)
Gets the
Coordinate along the
given linear Geometry which is
referenced by this location. |
static LinearLocation |
LinearLocation.getEndLocation(Geometry linear)
Gets a location which refers to the end of a linear
Geometry . |
static double |
LengthLocationMap.getLength(Geometry linearGeom,
LinearLocation loc)
Computes the length for a given
LinearLocation
on a linear Geometry . |
static LinearLocation |
LengthLocationMap.getLocation(Geometry linearGeom,
double length)
Computes the
LinearLocation for a
given length along a linear Geometry . |
static LinearLocation |
LengthLocationMap.getLocation(Geometry linearGeom,
double length,
boolean resolveLower)
Computes the
LinearLocation for a
given length along a linear Geometry ,
with control over how the location
is resolved at component endpoints. |
LineSegment |
LinearLocation.getSegment(Geometry linearGeom)
Gets a
LineSegment representing the segment of the
given linear Geometry which contains this location. |
double |
LinearLocation.getSegmentLength(Geometry linearGeom)
Gets the length of the segment in the given
Geometry containing this location.
|
LinearLocation[] |
LocationIndexedLine.indicesOf(Geometry subLine)
Computes the indices for a subline of the line.
|
double[] |
LengthIndexedLine.indicesOf(Geometry subLine)
Computes the indices for a subline of the line.
|
boolean |
LinearLocation.isEndpoint(Geometry linearGeom)
Tests whether this location is an endpoint of
the linear component it refers to.
|
boolean |
LinearLocation.isValid(Geometry linearGeom)
Tests whether this location refers to a valid
location on the given linear
Geometry . |
void |
LinearLocation.setToEnd(Geometry linear)
Sets the value of this location to
refer to the end of a linear geometry.
|
void |
LinearLocation.snapToVertex(Geometry linearGeom,
double minDistance)
Snaps the value of this location to
the nearest vertex on the given linear
Geometry ,
if the vertex is closer than minDistance. |
LinearLocation |
LinearLocation.toLowest(Geometry linearGeom)
Converts a linear location to the lowest equivalent location index.
|
Constructor and Description |
---|
LengthIndexedLine(Geometry linearGeom)
Constructs an object which allows a linear
Geometry
to be linearly referenced using length as an index. |
LengthLocationMap(Geometry linearGeom) |
LinearIterator(Geometry linear)
Creates an iterator initialized to the start of a linear
Geometry |
LinearIterator(Geometry linearGeom,
int componentIndex,
int vertexIndex)
Creates an iterator starting at
a specified component and vertex in a linear
Geometry |
LinearIterator(Geometry linear,
LinearLocation start)
Creates an iterator starting at
a
LinearLocation on a linear Geometry |
LocationIndexedLine(Geometry linearGeom)
Constructs an object which allows linear referencing along
a given linear
Geometry . |
Modifier and Type | Method and Description |
---|---|
static Geometry |
SegmentStringUtil.toGeometry(Collection segStrings,
GeometryFactory geomFact)
Converts a collection of
SegmentString s into a Geometry . |
Modifier and Type | Method and Description |
---|---|
static List |
SegmentStringUtil.extractNodedSegmentStrings(Geometry geom)
Extracts all linear components from a given
Geometry
to SegmentString s. |
static List |
SegmentStringUtil.extractSegmentStrings(Geometry geom)
Extracts all linear components from a given
Geometry
to SegmentString s. |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryGraphOperation.getArgGeometry(int i) |
Geometry |
BoundaryOp.getBoundary()
Gets the computed boundary.
|
static Geometry |
BoundaryOp.getBoundary(Geometry g)
Computes a geometry representing the boundary of a geometry.
|
static Geometry |
BoundaryOp.getBoundary(Geometry g,
BoundaryNodeRule bnRule)
Computes a geometry representing the boundary of a geometry,
using an explicit
BoundaryNodeRule . |
Modifier and Type | Method and Description |
---|---|
static Geometry |
BoundaryOp.getBoundary(Geometry g)
Computes a geometry representing the boundary of a geometry.
|
static Geometry |
BoundaryOp.getBoundary(Geometry g,
BoundaryNodeRule bnRule)
Computes a geometry representing the boundary of a geometry,
using an explicit
BoundaryNodeRule . |
Constructor and Description |
---|
BoundaryOp(Geometry geom)
Creates a new instance for the given geometry.
|
BoundaryOp(Geometry geom,
BoundaryNodeRule bnRule)
Creates a new instance for the given geometry.
|
GeometryGraphOperation(Geometry g0) |
GeometryGraphOperation(Geometry g0,
Geometry g1) |
GeometryGraphOperation(Geometry g0,
Geometry g1,
BoundaryNodeRule boundaryNodeRule) |
IsSimpleOp(Geometry geom)
Creates a simplicity checker using the default SFS Mod-2 Boundary Node Rule
|
IsSimpleOp(Geometry geom,
BoundaryNodeRule boundaryNodeRule)
Creates a simplicity checker using a given
BoundaryNodeRule |
Modifier and Type | Method and Description |
---|---|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance)
Computes the buffer of a geometry for a given buffer distance.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
BufferParameters params)
Computes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
int quadrantSegments)
Computes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
int quadrantSegments,
int endCapStyle)
Computes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
Geometry |
BufferOp.getResultGeometry(double distance)
Returns the buffer computed for a geometry for a given buffer distance.
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance)
Computes the buffer of a geometry for a given buffer distance.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
BufferParameters params)
Computes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
int quadrantSegments)
Computes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
int quadrantSegments,
int endCapStyle)
Computes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
Constructor and Description |
---|
BufferOp(Geometry g)
Initializes a buffer computation for the given geometry
|
BufferOp(Geometry g,
BufferParameters bufParams)
Initializes a buffer computation for the given geometry
with the given set of parameters
|
OffsetCurveSetBuilder(Geometry inputGeom,
double distance,
OffsetCurveBuilder curveBuilder) |
Modifier and Type | Method and Description |
---|---|
Geometry |
BufferResultValidator.getErrorIndicator()
Gets a geometry which indicates the location and nature of a validation failure.
|
Geometry |
BufferDistanceValidator.getErrorIndicator()
Gets a geometry which indicates the location and nature of a validation failure.
|
Modifier and Type | Method and Description |
---|---|
static void |
DistanceToPointFinder.computeDistance(Geometry geom,
Coordinate pt,
PointPairDistance ptDist) |
double |
BufferCurveMaximumDistanceFinder.findDistance(Geometry bufferCurve) |
static boolean |
BufferResultValidator.isValid(Geometry g,
double distance,
Geometry result) |
static String |
BufferResultValidator.isValidMsg(Geometry g,
double distance,
Geometry result)
Checks whether the geometry buffer is valid,
and returns an error message if not.
|
Constructor and Description |
---|
BufferCurveMaximumDistanceFinder(Geometry inputGeom) |
BufferDistanceValidator(Geometry input,
double bufDistance,
Geometry result) |
BufferResultValidator(Geometry input,
double distance,
Geometry result) |
MaxMidpointDistanceFilter(Geometry geom) |
MaxPointDistanceFilter(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryLocation.getGeometryComponent()
Returns the geometry component on (or in) which this location occurs.
|
Modifier and Type | Method and Description |
---|---|
static STRtree |
FacetSequenceTreeBuilder.build(Geometry g) |
static Coordinate[] |
DistanceOp.closestPoints(Geometry g0,
Geometry g1)
Deprecated.
renamed to nearestPoints
|
double |
IndexedFacetDistance.distance(Geometry g)
Computes the distance from the base geometry to
the given geometry.
|
static double |
IndexedFacetDistance.distance(Geometry g1,
Geometry g2)
Computes the distance between two geometries using
the indexed approach.
|
static double |
DistanceOp.distance(Geometry g0,
Geometry g1)
Compute the distance between the nearest points of two geometries.
|
void |
ConnectedElementLocationFilter.filter(Geometry geom) |
void |
ConnectedElementPointFilter.filter(Geometry geom) |
static List |
ConnectedElementPointFilter.getCoordinates(Geometry geom)
Returns a list containing a Coordinate from each Polygon, LineString, and Point
found inside the specified geometry.
|
static List |
ConnectedElementLocationFilter.getLocations(Geometry geom)
Returns a list containing a point from each Polygon, LineString, and Point
found inside the specified geometry.
|
static boolean |
DistanceOp.isWithinDistance(Geometry g0,
Geometry g1,
double distance)
Test whether two geometries lie within a given distance of each other.
|
GeometryLocation[] |
IndexedFacetDistance.nearestLocations(Geometry g)
Computes the nearest locations on the base geometry
and the given geometry.
|
Coordinate[] |
IndexedFacetDistance.nearestPoints(Geometry g)
Compute the nearest locations on the target geometry
and the given geometry.
|
static Coordinate[] |
IndexedFacetDistance.nearestPoints(Geometry g1,
Geometry g2)
Computes the nearest points on two geometries.
|
static Coordinate[] |
DistanceOp.nearestPoints(Geometry g0,
Geometry g1)
Compute the the nearest points of two geometries.
|
Constructor and Description |
---|
DistanceOp(Geometry g0,
Geometry g1)
Constructs a DistanceOp that computes the distance and nearest points between
the two specified geometries.
|
DistanceOp(Geometry g0,
Geometry g1,
double terminateDistance)
Constructs a DistanceOp that computes the distance and nearest points between
the two specified geometries.
|
FacetSequence(Geometry geom,
CoordinateSequence pts,
int start,
int end)
Creates a new sequence of facets based on a
CoordinateSequence
contained in the given Geometry . |
GeometryLocation(Geometry component,
Coordinate pt)
Constructs a GeometryLocation specifying a point inside an area geometry.
|
GeometryLocation(Geometry component,
int segIndex,
Coordinate pt)
Constructs a GeometryLocation specifying a point on a geometry, as well as the
segment that the point is on
(or
GeometryLocation.INSIDE_AREA if the point is not on a segment). |
IndexedFacetDistance(Geometry g1)
Creates a new distance-finding instance for a given target
Geometry . |
Modifier and Type | Method and Description |
---|---|
static double |
Distance3DOp.distance(Geometry g0,
Geometry g1)
Compute the distance between the nearest points of two geometries.
|
static boolean |
Distance3DOp.isWithinDistance(Geometry g0,
Geometry g1,
double distance)
Test whether two geometries lie within a given distance of each other.
|
static Coordinate[] |
Distance3DOp.nearestPoints(Geometry g0,
Geometry g1)
Compute the the nearest points of two geometries.
|
Constructor and Description |
---|
Distance3DOp(Geometry g0,
Geometry g1)
Constructs a DistanceOp that computes the distance and nearest points
between the two specified geometries.
|
Distance3DOp(Geometry g0,
Geometry g1,
double terminateDistance)
Constructs a DistanceOp that computes the distance and nearest points
between the two specified geometries.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
LineSequencer.getSequencedLineStrings()
Returns the
LineString or MultiLineString
built by the sequencing process, if one exists. |
static Geometry |
LineSequencer.sequence(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
void |
LineMerger.add(Geometry geometry)
Adds a Geometry to be processed.
|
void |
LineSequencer.add(Geometry geometry)
Adds a
Geometry to be sequenced. |
static boolean |
LineSequencer.isSequenced(Geometry geom)
Tests whether a
Geometry is sequenced correctly. |
static Geometry |
LineSequencer.sequence(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
OverlayOp.createEmptyResult(int overlayOpCode,
Geometry a,
Geometry b,
GeometryFactory geomFact)
Creates an empty result geometry of the appropriate dimension,
based on the given overlay operation and the dimensions of the inputs.
|
Geometry |
OverlayOp.getResultGeometry(int overlayOpCode)
Gets the result of the overlay for a given overlay operation.
|
static Geometry |
OverlayOp.overlayOp(Geometry geom0,
Geometry geom1,
int opCode)
Computes an overlay operation for
the given geometry arguments.
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
OverlayOp.createEmptyResult(int overlayOpCode,
Geometry a,
Geometry b,
GeometryFactory geomFact)
Creates an empty result geometry of the appropriate dimension,
based on the given overlay operation and the dimensions of the inputs.
|
static Geometry |
OverlayOp.overlayOp(Geometry geom0,
Geometry geom1,
int opCode)
Computes an overlay operation for
the given geometry arguments.
|
Constructor and Description |
---|
OverlayOp(Geometry g0,
Geometry g1)
Constructs an instance to compute a single overlay operation
for the given geometries.
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
SnapIfNeededOverlayOp.difference(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.difference(Geometry g0,
Geometry g1) |
Geometry |
SnapIfNeededOverlayOp.getResultGeometry(int opCode) |
Geometry |
SnapOverlayOp.getResultGeometry(int opCode) |
static Geometry |
SnapIfNeededOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.overlayOp(Geometry g0,
Geometry g1,
int opCode) |
static Geometry |
SnapOverlayOp.overlayOp(Geometry g0,
Geometry g1,
int opCode) |
static Geometry[] |
GeometrySnapper.snap(Geometry g0,
Geometry g1,
double snapTolerance)
Snaps two geometries together with a given tolerance.
|
Geometry |
GeometrySnapper.snapTo(Geometry snapGeom,
double snapTolerance)
Snaps the vertices in the component
LineString s
of the source geometry
to the vertices of the given snap geometry. |
Geometry |
GeometrySnapper.snapToSelf(double snapTolerance,
boolean cleanResult)
Snaps the vertices in the component
LineString s
of the source geometry
to the vertices of the same geometry. |
static Geometry |
GeometrySnapper.snapToSelf(Geometry geom,
double snapTolerance,
boolean cleanResult)
Snaps a geometry to itself.
|
static Geometry |
SnapIfNeededOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.union(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.union(Geometry g0,
Geometry g1) |
Modifier and Type | Method and Description |
---|---|
static double |
GeometrySnapper.computeOverlaySnapTolerance(Geometry g)
Estimates the snap tolerance for a Geometry, taking into account its precision model.
|
static double |
GeometrySnapper.computeOverlaySnapTolerance(Geometry g0,
Geometry g1) |
static double |
GeometrySnapper.computeSizeBasedSnapTolerance(Geometry g) |
static Geometry |
SnapIfNeededOverlayOp.difference(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.difference(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.overlayOp(Geometry g0,
Geometry g1,
int opCode) |
static Geometry |
SnapOverlayOp.overlayOp(Geometry g0,
Geometry g1,
int opCode) |
static Geometry[] |
GeometrySnapper.snap(Geometry g0,
Geometry g1,
double snapTolerance)
Snaps two geometries together with a given tolerance.
|
Geometry |
GeometrySnapper.snapTo(Geometry snapGeom,
double snapTolerance)
Snaps the vertices in the component
LineString s
of the source geometry
to the vertices of the given snap geometry. |
static Geometry |
GeometrySnapper.snapToSelf(Geometry geom,
double snapTolerance,
boolean cleanResult)
Snaps a geometry to itself.
|
static Geometry |
SnapIfNeededOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.union(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.union(Geometry g0,
Geometry g1) |
Constructor and Description |
---|
GeometrySnapper(Geometry srcGeom)
Creates a new snapper acting on the given geometry
|
SnapIfNeededOverlayOp(Geometry g1,
Geometry g2) |
SnapOverlayOp(Geometry g1,
Geometry g2) |
Modifier and Type | Method and Description |
---|---|
static boolean |
OverlayResultValidator.isValid(Geometry a,
Geometry b,
int overlayOp,
Geometry result) |
Constructor and Description |
---|
FuzzyPointLocator(Geometry g,
double boundaryDistanceTolerance) |
OffsetPointGenerator(Geometry g) |
OverlayResultValidator(Geometry a,
Geometry b,
Geometry result) |
Modifier and Type | Method and Description |
---|---|
Geometry |
Polygonizer.getGeometry()
Gets a geometry representing the polygons formed by the polygonization.
|
Modifier and Type | Method and Description |
---|---|
void |
Polygonizer.add(Geometry g)
Add a
Geometry to the edges to be polygonized. |
Modifier and Type | Method and Description |
---|---|
boolean |
RectangleContains.contains(Geometry geom) |
static boolean |
RectangleContains.contains(Polygon rectangle,
Geometry b)
Tests whether a rectangle contains a given geometry.
|
boolean |
RectangleIntersects.intersects(Geometry geom)
Tests whether the given Geometry intersects
the query rectangle.
|
static boolean |
RectangleIntersects.intersects(Polygon rectangle,
Geometry b)
Tests whether a rectangle intersects a given geometry.
|
Modifier and Type | Method and Description |
---|---|
static IntersectionMatrix |
RelateOp.relate(Geometry a,
Geometry b)
Computes the
IntersectionMatrix for the spatial relationship
between two Geometry s, using the default (OGC SFS) Boundary Node Rule |
static IntersectionMatrix |
RelateOp.relate(Geometry a,
Geometry b,
BoundaryNodeRule boundaryNodeRule)
Computes the
IntersectionMatrix for the spatial relationship
between two Geometry s using a specified Boundary Node Rule. |
Constructor and Description |
---|
RelateOp(Geometry g0,
Geometry g1)
Creates a new Relate operation, using the default (OGC SFS) Boundary Node Rule.
|
RelateOp(Geometry g0,
Geometry g1,
BoundaryNodeRule boundaryNodeRule)
Creates a new Relate operation with a specified Boundary Node Rule.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
CascadedPolygonUnion.union()
Computes the union of the input geometries.
|
Geometry |
PointGeometryUnion.union() |
Geometry |
UnionInteracting.union() |
Geometry |
UnaryUnionOp.union()
Gets the union of the input geometries.
|
static Geometry |
CascadedPolygonUnion.union(Collection polys)
|
static Geometry |
UnaryUnionOp.union(Collection geoms)
Computes the geometric union of a
Collection
of Geometry s. |
static Geometry |
UnaryUnionOp.union(Collection geoms,
GeometryFactory geomFact)
Computes the geometric union of a
Collection
of Geometry s. |
static Geometry |
UnaryUnionOp.union(Geometry geom)
Constructs a unary union operation for a
Geometry
(which may be a GeometryCollection ). |
static Geometry |
UnionInteracting.union(Geometry g0,
Geometry g1) |
static Geometry |
PointGeometryUnion.union(Puntal pointGeom,
Geometry otherGeom) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
UnaryUnionOp.union(Geometry geom)
Constructs a unary union operation for a
Geometry
(which may be a GeometryCollection ). |
static Geometry |
UnionInteracting.union(Geometry g0,
Geometry g1) |
static Geometry |
PointGeometryUnion.union(Puntal pointGeom,
Geometry otherGeom) |
Constructor and Description |
---|
PointGeometryUnion(Puntal pointGeom,
Geometry otherGeom) |
UnaryUnionOp(Geometry geom)
Constructs a unary union operation for a
Geometry
(which may be a GeometryCollection ). |
UnionInteracting(Geometry g0,
Geometry g1) |
Modifier and Type | Method and Description |
---|---|
boolean |
RepeatedPointTester.hasRepeatedPoint(Geometry g) |
static boolean |
IsValidOp.isValid(Geometry geom)
Tests whether a
Geometry is valid. |
Constructor and Description |
---|
IsValidOp(Geometry parentGeometry) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
EnhancedPrecisionOp.buffer(Geometry geom,
double distance)
Computes the buffer of a
Geometry , using enhanced precision. |
Geometry |
CommonBitsOp.buffer(Geometry geom0,
double distance)
Computes the buffer a geometry,
using enhanced precision.
|
static Geometry |
EnhancedPrecisionOp.difference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic difference of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.difference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic difference of two
Geometry s, using enhanced precision. |
static Geometry |
SimpleMinimumClearance.getLine(Geometry g) |
static Geometry |
MinimumClearance.getLine(Geometry g)
Gets a LineString containing two points
which are at the Minimum Clearance distance
for the given Geometry.
|
static Geometry |
EnhancedPrecisionOp.intersection(Geometry geom0,
Geometry geom1)
Computes the set-theoretic intersection of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.intersection(Geometry geom0,
Geometry geom1)
Computes the set-theoretic intersection of two
Geometry s, using enhanced precision. |
Geometry |
SimpleGeometryPrecisionReducer.reduce(Geometry geom)
Deprecated.
|
Geometry |
GeometryPrecisionReducer.reduce(Geometry geom) |
static Geometry |
SimpleGeometryPrecisionReducer.reduce(Geometry g,
PrecisionModel precModel)
Deprecated.
Convenience method for doing precision reduction on a single geometry,
with collapses removed and keeping the geometry precision model the same.
|
static Geometry |
GeometryPrecisionReducer.reduce(Geometry g,
PrecisionModel precModel)
Convenience method for doing precision reduction
on a single geometry,
with collapses removed
and keeping the geometry precision model the same,
and preserving polygonal topology.
|
static Geometry |
GeometryPrecisionReducer.reducePointwise(Geometry g,
PrecisionModel precModel)
Convenience method for doing pointwise precision reduction
on a single geometry,
with collapses removed
and keeping the geometry precision model the same,
but NOT preserving valid polygonal topology.
|
Geometry |
CommonBitsRemover.removeCommonBits(Geometry geom)
Removes the common coordinate bits from a Geometry.
|
static Geometry |
EnhancedPrecisionOp.symDifference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic symmetric difference of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.symDifference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic symmetric difference of two geometries,
using enhanced precision.
|
static Geometry |
EnhancedPrecisionOp.union(Geometry geom0,
Geometry geom1)
Computes the set-theoretic union of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.union(Geometry geom0,
Geometry geom1)
Computes the set-theoretic union of two
Geometry s, using enhanced precision. |
Modifier and Type | Method and Description |
---|---|
void |
CommonBitsRemover.add(Geometry geom)
Add a geometry to the set of geometries whose common bits are
being computed.
|
void |
CommonBitsRemover.addCommonBits(Geometry geom)
Adds the common coordinate bits back into a Geometry.
|
static Geometry |
EnhancedPrecisionOp.buffer(Geometry geom,
double distance)
Computes the buffer of a
Geometry , using enhanced precision. |
Geometry |
CommonBitsOp.buffer(Geometry geom0,
double distance)
Computes the buffer a geometry,
using enhanced precision.
|
static Geometry |
EnhancedPrecisionOp.difference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic difference of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.difference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic difference of two
Geometry s, using enhanced precision. |
Coordinate[] |
PrecisionReducerCoordinateOperation.edit(Coordinate[] coordinates,
Geometry geom) |
static double |
SimpleMinimumClearance.getDistance(Geometry g) |
static double |
MinimumClearance.getDistance(Geometry g)
Computes the Minimum Clearance distance for
the given Geometry.
|
static Geometry |
SimpleMinimumClearance.getLine(Geometry g) |
static Geometry |
MinimumClearance.getLine(Geometry g)
Gets a LineString containing two points
which are at the Minimum Clearance distance
for the given Geometry.
|
static Geometry |
EnhancedPrecisionOp.intersection(Geometry geom0,
Geometry geom1)
Computes the set-theoretic intersection of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.intersection(Geometry geom0,
Geometry geom1)
Computes the set-theoretic intersection of two
Geometry s, using enhanced precision. |
Geometry |
SimpleGeometryPrecisionReducer.reduce(Geometry geom)
Deprecated.
|
Geometry |
GeometryPrecisionReducer.reduce(Geometry geom) |
static Geometry |
SimpleGeometryPrecisionReducer.reduce(Geometry g,
PrecisionModel precModel)
Deprecated.
Convenience method for doing precision reduction on a single geometry,
with collapses removed and keeping the geometry precision model the same.
|
static Geometry |
GeometryPrecisionReducer.reduce(Geometry g,
PrecisionModel precModel)
Convenience method for doing precision reduction
on a single geometry,
with collapses removed
and keeping the geometry precision model the same,
and preserving polygonal topology.
|
static Geometry |
GeometryPrecisionReducer.reducePointwise(Geometry g,
PrecisionModel precModel)
Convenience method for doing pointwise precision reduction
on a single geometry,
with collapses removed
and keeping the geometry precision model the same,
but NOT preserving valid polygonal topology.
|
Geometry |
CommonBitsRemover.removeCommonBits(Geometry geom)
Removes the common coordinate bits from a Geometry.
|
static Geometry |
EnhancedPrecisionOp.symDifference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic symmetric difference of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.symDifference(Geometry geom0,
Geometry geom1)
Computes the set-theoretic symmetric difference of two geometries,
using enhanced precision.
|
static Geometry |
EnhancedPrecisionOp.union(Geometry geom0,
Geometry geom1)
Computes the set-theoretic union of two
Geometry s, using enhanced precision. |
Geometry |
CommonBitsOp.union(Geometry geom0,
Geometry geom1)
Computes the set-theoretic union of two
Geometry s, using enhanced precision. |
Constructor and Description |
---|
MinimumClearance(Geometry geom)
Creates an object to compute the Minimum Clearance
for the given Geometry
|
SimpleMinimumClearance(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
abstract Geometry |
GeometricShapeBuilder.getGeometry() |
Modifier and Type | Method and Description |
---|---|
Geometry |
SierpinskiCarpetBuilder.getGeometry() |
Geometry |
HilbertCurveBuilder.getGeometry() |
Geometry |
MortonCurveBuilder.getGeometry() |
Geometry |
KochSnowflakeBuilder.getGeometry() |
Modifier and Type | Method and Description |
---|---|
Geometry |
RandomPointsInGridBuilder.getGeometry()
Gets the
MultiPoint containing the generated point |
Geometry |
RandomPointsBuilder.getGeometry() |
Modifier and Type | Method and Description |
---|---|
void |
RandomPointsBuilder.setExtent(Geometry mask)
Sets a polygonal mask.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
TopologyPreservingSimplifier.getResultGeometry() |
Geometry |
VWSimplifier.getResultGeometry()
Gets the simplified geometry.
|
Geometry |
DouglasPeuckerSimplifier.getResultGeometry()
Gets the simplified geometry.
|
static Geometry |
TopologyPreservingSimplifier.simplify(Geometry geom,
double distanceTolerance) |
static Geometry |
VWSimplifier.simplify(Geometry geom,
double distanceTolerance)
Simplifies a geometry using a given tolerance.
|
static Geometry |
DouglasPeuckerSimplifier.simplify(Geometry geom,
double distanceTolerance)
Simplifies a geometry using a given tolerance.
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
TopologyPreservingSimplifier.simplify(Geometry geom,
double distanceTolerance) |
static Geometry |
VWSimplifier.simplify(Geometry geom,
double distanceTolerance)
Simplifies a geometry using a given tolerance.
|
static Geometry |
DouglasPeuckerSimplifier.simplify(Geometry geom,
double distanceTolerance)
Simplifies a geometry using a given tolerance.
|
Constructor and Description |
---|
DouglasPeuckerSimplifier(Geometry inputGeom)
Creates a simplifier for a given geometry.
|
TopologyPreservingSimplifier(Geometry inputGeom) |
VWSimplifier(Geometry inputGeom)
Creates a simplifier for a given geometry.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
ConformingDelaunayTriangulator.getConvexHull()
Gets the convex hull of all the sites in the triangulation,
including constraint vertices.
|
Geometry |
VoronoiDiagramBuilder.getDiagram(GeometryFactory geomFact)
Gets the faces of the computed diagram as a
GeometryCollection
of Polygon s, clipped as specified. |
Geometry |
ConformingDelaunayTriangulationBuilder.getEdges(GeometryFactory geomFact)
Gets the edges of the computed triangulation as a
MultiLineString . |
Geometry |
DelaunayTriangulationBuilder.getEdges(GeometryFactory geomFact)
Gets the edges of the computed triangulation as a
MultiLineString . |
Geometry |
ConformingDelaunayTriangulationBuilder.getTriangles(GeometryFactory geomFact)
Gets the faces of the computed triangulation as a
GeometryCollection
of Polygon . |
Geometry |
DelaunayTriangulationBuilder.getTriangles(GeometryFactory geomFact)
Gets the faces of the computed triangulation as a
GeometryCollection
of Polygon . |
Modifier and Type | Method and Description |
---|---|
static CoordinateList |
DelaunayTriangulationBuilder.extractUniqueCoordinates(Geometry geom)
Extracts the unique
Coordinate s from the given Geometry . |
void |
VertexTaggedGeometryDataMapper.loadSourceGeometries(Geometry geomColl) |
void |
ConformingDelaunayTriangulationBuilder.setConstraints(Geometry constraintLines)
Sets the linear constraints to be conformed to.
|
void |
ConformingDelaunayTriangulationBuilder.setSites(Geometry geom)
Sets the sites (point or vertices) which will be triangulated.
|
void |
DelaunayTriangulationBuilder.setSites(Geometry geom)
Sets the sites (vertices) which will be triangulated.
|
void |
VoronoiDiagramBuilder.setSites(Geometry geom)
Sets the sites (point or vertices) which will be diagrammed.
|
void |
VertexTaggedGeometryDataMapper.transferData(Geometry targetGeom)
Input is assumed to be a multiGeometry
in which every component has its userData
set to be a Coordinate which is the key to the output data.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
QuadEdgeSubdivision.getEdges(GeometryFactory geomFact)
Gets the geometry for the edges in the subdivision as a
MultiLineString
containing 2-point lines. |
Geometry |
QuadEdgeSubdivision.getTriangles(GeometryFactory geomFact)
Gets the geometry for the triangles in a triangulated subdivision as a
GeometryCollection
of triangular Polygon s. |
Geometry |
QuadEdgeSubdivision.getVoronoiDiagram(GeometryFactory geomFact)
Gets the cells in the Voronoi diagram for this triangulation.
|
static Geometry |
QuadEdgeTriangle.toPolygon(QuadEdge[] e) |
static Geometry |
QuadEdgeTriangle.toPolygon(Vertex[] v) |
Modifier and Type | Method and Description |
---|---|
static boolean |
Debug.hasSegment(Geometry geom,
Coordinate p0,
Coordinate p1) |
Copyright © 2019. All rights reserved.