Package | Description |
---|---|
com.vividsolutions.jts.algorithm |
Contains classes and interfaces implementing fundamental computational geometry algorithms.
|
com.vividsolutions.jts.algorithm.distance |
Classes to compute distance metrics between geonetries.
|
com.vividsolutions.jts.algorithm.locate |
Classes to determine the topological location of points in geometries.
|
com.vividsolutions.jts.algorithm.match |
Classes to compute matching metrics between geometries.
|
com.vividsolutions.jts.awt |
Classes to perform conversions from Java2D shape objects.
|
com.vividsolutions.jts.densify |
Classes to perform densification on geometries.
|
com.vividsolutions.jts.dissolve | |
com.vividsolutions.jts.edgegraph | |
com.vividsolutions.jts.geom |
Contains the
Geometry interface hierarchy and supporting classes. |
com.vividsolutions.jts.geom.prep |
Classes to perform optimized geometric operations on suitably prepared geometries.
|
com.vividsolutions.jts.geom.util |
Provides classes that parse and modify Geometry objects.
|
com.vividsolutions.jts.geomgraph |
Contains classes that implement topology graphs.
|
com.vividsolutions.jts.io |
Contains the interfaces for converting JTS objects to and from other formats.
|
com.vividsolutions.jts.io.geojson | |
com.vividsolutions.jts.io.gml2 |
Classes to read and write the GML2 geometry format.
|
com.vividsolutions.jts.io.kml | |
com.vividsolutions.jts.linearref |
Contains classes and interfaces implementing linear referencing on linear geometries
|
com.vividsolutions.jts.noding |
Classes to compute nodings for arrangements of line segments and line segment sequences.
|
com.vividsolutions.jts.operation |
Provides classes for implementing operations on geometries
|
com.vividsolutions.jts.operation.buffer |
Provides classes for computing buffers of geometries
|
com.vividsolutions.jts.operation.buffer.validate |
Classes to perform validation of the results of buffer operations.
|
com.vividsolutions.jts.operation.distance |
Provides classes for computing the distance between geometries
|
com.vividsolutions.jts.operation.distance3d | |
com.vividsolutions.jts.operation.linemerge |
Classes to perform line merging.
|
com.vividsolutions.jts.operation.overlay |
Contains classes that perform a topological overlay to compute boolean spatial functions.
|
com.vividsolutions.jts.operation.overlay.snap |
Classes to perform snapping on geometries to prepare them for overlay operations.
|
com.vividsolutions.jts.operation.overlay.validate |
Classes to validate the results of overlay operations.
|
com.vividsolutions.jts.operation.polygonize |
An API for polygonizing sets of lines.
|
com.vividsolutions.jts.operation.predicate |
Classes which implement topological predicates optimized for particular kinds of geometries.
|
com.vividsolutions.jts.operation.relate |
Contains classes to implement the computation of the spatial relationships of
Geometry s. |
com.vividsolutions.jts.operation.union |
Classes to perform efficent unioning of collections of geometries.
|
com.vividsolutions.jts.operation.valid |
Provides classes for testing the validity of geometries.
|
com.vividsolutions.jts.precision |
Provides classes for analyzing and
manipulating the precision of Geometries.
|
com.vividsolutions.jts.shape | |
com.vividsolutions.jts.shape.fractal | |
com.vividsolutions.jts.shape.random | |
com.vividsolutions.jts.simplify |
Classes which implement algorithms for simplifying or generalizing geometries.
|
com.vividsolutions.jts.triangulate |
Classes to compute Delaunay triangulations.
|
com.vividsolutions.jts.triangulate.quadedge |
Classes to implement a topological subdivision of quadeges, to support creating triangulations
and Voronoi diagrams.
|
com.vividsolutions.jts.util |
Contains support classes for the Java Topology Suite.
|
com.vividsolutions.jtsexample.technique | |
com.vividsolutions.jtstest.clean | |
com.vividsolutions.jtstest.function | |
com.vividsolutions.jtstest.geomop | |
com.vividsolutions.jtstest.test | |
com.vividsolutions.jtstest.testbuilder | |
com.vividsolutions.jtstest.testbuilder.controller | |
com.vividsolutions.jtstest.testbuilder.geom | |
com.vividsolutions.jtstest.testbuilder.io.shapefile | |
com.vividsolutions.jtstest.testbuilder.model | |
com.vividsolutions.jtstest.testbuilder.topostretch | |
com.vividsolutions.jtstest.testbuilder.ui | |
com.vividsolutions.jtstest.testbuilder.ui.render | |
com.vividsolutions.jtstest.testbuilder.ui.style | |
com.vividsolutions.jtstest.testbuilder.ui.tools | |
com.vividsolutions.jtstest.testrunner | |
com.vividsolutions.jtstest.util | |
com.vividsolutions.jtstest.util.io |
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 |
---|---|
void |
CentroidLine.add(Geometry geom)
Deprecated.
Adds the linear components of by a Geometry to the centroid total.
|
void |
CentroidPoint.add(Geometry geom)
Deprecated.
Adds the point(s) defined by a Geometry to the centroid total.
|
void |
CentroidArea.add(Geometry geom)
Deprecated.
Adds the area defined by a Geometry to the centroid total.
|
static Coordinate |
Centroid.getCentroid(Geometry geom)
Computes the centroid point 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.
|
protected LineString |
InteriorPointArea.horizontalBisector(Geometry 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 int |
SimplePointInAreaLocator.locate(Coordinate p,
Geometry geom)
|
Constructor and Description |
---|
IndexedPointInAreaLocator(Geometry g)
Creates a new locator for a given
Geometry |
SimplePointInAreaLocator(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
double |
AreaSimilarityMeasure.measure(Geometry g1,
Geometry g2) |
double |
SimilarityMeasure.measure(Geometry g1,
Geometry g2) |
double |
HausdorffSimilarityMeasure.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 (@link 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 | Field and Description |
---|---|
protected Geometry[] |
GeometryCollection.geometries
Internal representation of this
GeometryCollection . |
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 |
Polygon.convexHull() |
Geometry |
Geometry.convexHull()
Computes the smallest convex
Polygon that contains all the
points in the Geometry . |
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. |
Geometry |
LineString.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
Point.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
Polygon.getBoundary()
Computes the boundary of this geometry
|
Geometry |
MultiLineString.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
MultiPoint.getBoundary()
Gets the boundary of this geometry.
|
Geometry |
GeometryCollection.getBoundary() |
Geometry |
MultiPolygon.getBoundary()
Computes the boundary of this geometry
|
abstract Geometry |
Geometry.getBoundary()
Returns the boundary, or an empty geometry of appropriate dimension
if this
Geometry is empty. |
Geometry |
Geometry.getEnvelope()
Gets a Geometry representing the envelope (bounding box) of
this
Geometry . |
Geometry |
GeometryCollection.getGeometryN(int n) |
Geometry |
Geometry.getGeometryN(int n)
Returns an element
Geometry from a GeometryCollection
(or this , if the geometry is not a collection). |
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
|
Geometry |
LineString.reverse()
Creates a
LineString whose coordinates are in the reverse
order of this objects |
Geometry |
Point.reverse() |
Geometry |
Polygon.reverse() |
Geometry |
MultiLineString.reverse()
Creates a
MultiLineString in the reverse
order to this object. |
Geometry |
GeometryCollection.reverse()
Creates a
GeometryCollection with
every component reversed. |
Geometry |
LinearRing.reverse() |
Geometry |
MultiPolygon.reverse()
Creates a
MultiPolygon with
every component reversed. |
abstract Geometry |
Geometry.reverse()
Computes a new geometry which has all component coordinate sequences
in reverse order (opposite orientation) to this one.
|
Geometry |
Geometry.symDifference(Geometry other)
Computes a
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 |
---|---|
protected void |
Geometry.checkNotGeometryCollection(Geometry g)
Throws an exception if
g 's class is GeometryCollection
. |
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. |
boolean |
LineString.equalsExact(Geometry other,
double tolerance) |
boolean |
Point.equalsExact(Geometry other,
double tolerance) |
boolean |
Polygon.equalsExact(Geometry other,
double tolerance) |
boolean |
MultiLineString.equalsExact(Geometry other,
double tolerance) |
boolean |
MultiPoint.equalsExact(Geometry other,
double tolerance) |
boolean |
GeometryCollection.equalsExact(Geometry other,
double tolerance) |
boolean |
MultiPolygon.equalsExact(Geometry other,
double tolerance) |
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 |
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 |
GeometryComponentFilter.filter(Geometry geom)
Performs an operation with or on
geom . |
void |
GeometryFilter.filter(Geometry geom)
Performs an operation with or on
geom . |
protected static boolean |
Geometry.hasNonEmptyElements(Geometry[] geometries)
Returns true if the array contains any non-empty
Geometry s. |
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.
|
protected boolean |
LineString.isEquivalentClass(Geometry other) |
protected boolean |
Geometry.isEquivalentClass(Geometry other)
Returns whether the two
Geometry s are equal, from the point
of view of the equalsExact method. |
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 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 |
PreparedGeometry.contains(Geometry geom)
Tests whether the base
Geometry contains a given geometry. |
boolean |
PreparedPolygon.contains(Geometry g) |
boolean |
PreparedGeometry.containsProperly(Geometry geom)
Tests whether the base
Geometry properly contains a given geometry. |
boolean |
PreparedPolygon.containsProperly(Geometry g) |
boolean |
PreparedGeometry.coveredBy(Geometry geom)
Tests whether the base
Geometry is covered by a given geometry. |
boolean |
PreparedGeometry.covers(Geometry geom)
Tests whether the base
Geometry covers a given geometry. |
boolean |
PreparedPolygon.covers(Geometry g) |
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 |
PreparedLineString.intersects(Geometry g) |
boolean |
PreparedGeometry.intersects(Geometry geom)
Tests whether the base
Geometry intersects a given geometry. |
boolean |
PreparedPolygon.intersects(Geometry g) |
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.
|
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 {@link MultiLineString}. |
static Geometry |
LineStringExtracter.getGeometry(Geometry geom)
Extracts the
LineString elements from a single Geometry
and returns them as either a LineString) or {@link 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 {@link 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)
Cretaes a new @link Geometry which is the result
of this transformation applied to the input Geometry.
|
protected Geometry |
GeometryTransformer.transformGeometryCollection(GeometryCollection geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformLinearRing(LinearRing geom,
Geometry parent)
Transforms a LinearRing.
|
protected Geometry |
GeometryTransformer.transformLineString(LineString geom,
Geometry parent)
Transforms a
LineString geometry. |
protected Geometry |
GeometryTransformer.transformMultiLineString(MultiLineString geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformMultiPoint(MultiPoint geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformMultiPolygon(MultiPolygon geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformPoint(Point geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformPolygon(Polygon geom,
Geometry parent) |
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 |
PolygonExtracter.filter(Geometry geom) |
void |
LinearComponentExtracter.filter(Geometry geom) |
void |
GeometryExtracter.filter(Geometry geom) |
void |
ComponentCoordinateExtracter.filter(Geometry geom) |
void |
PointExtracter.filter(Geometry geom) |
void |
LineStringExtracter.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 {@link MultiLineString}. |
static Geometry |
LineStringExtracter.getGeometry(Geometry geom)
Extracts the
LineString elements from a single Geometry
and returns them as either a LineString) or {@link 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 {@link 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)
Cretaes a new @link Geometry which is the result
of this transformation applied to the input Geometry.
|
protected CoordinateSequence |
GeometryTransformer.transformCoordinates(CoordinateSequence coords,
Geometry parent)
Transforms a
CoordinateSequence . |
protected Geometry |
GeometryTransformer.transformGeometryCollection(GeometryCollection geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformLinearRing(LinearRing geom,
Geometry parent)
Transforms a LinearRing.
|
protected Geometry |
GeometryTransformer.transformLineString(LineString geom,
Geometry parent)
Transforms a
LineString geometry. |
protected Geometry |
GeometryTransformer.transformMultiLineString(MultiLineString geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformMultiPoint(MultiPoint geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformMultiPolygon(MultiPolygon geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformPoint(Point geom,
Geometry parent) |
protected Geometry |
GeometryTransformer.transformPolygon(Polygon geom,
Geometry parent) |
protected abstract void |
ShortCircuitedGeometryVisitor.visit(Geometry element) |
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 |
---|---|
String |
WKTWriter.write(Geometry geometry)
Converts a
Geometry to its Well-known Text representation. |
byte[] |
WKBWriter.write(Geometry geom)
Writes a
Geometry into a byte array. |
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 |
GeoJsonReader.read(Reader reader)
|
Geometry |
GeoJsonReader.read(String json)
Reads a GeoJson Geometry from a String into a single
Geometry . |
Modifier and Type | Method and Description |
---|---|
String |
GeoJsonWriter.write(Geometry geometry)
Writes a
Geometry in GeoJson format to a String. |
void |
GeoJsonWriter.write(Geometry geometry,
Writer writer)
|
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.
|
double[] |
LengthIndexedLine.indicesOf(Geometry subLine)
Computes the indices for a subline of the line.
|
LinearLocation[] |
LocationIndexedLine.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() |
static Geometry |
BoundaryOp.getBoundary(Geometry g) |
static Geometry |
BoundaryOp.getBoundary(Geometry g,
BoundaryNodeRule bnRule) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
BoundaryOp.getBoundary(Geometry g) |
static Geometry |
BoundaryOp.getBoundary(Geometry g,
BoundaryNodeRule bnRule) |
Constructor and Description |
---|
BoundaryOp(Geometry geom) |
BoundaryOp(Geometry geom,
BoundaryNodeRule bnRule) |
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)
Comutes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
int quadrantSegments)
Comutes 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)
Comutes 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)
Comutes the buffer for a geometry for a given buffer distance
and accuracy of approximation.
|
static Geometry |
BufferOp.bufferOp(Geometry g,
double distance,
int quadrantSegments)
Comutes 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)
Comutes 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 |
BufferDistanceValidator.getErrorIndicator()
Gets a geometry which indicates the location and nature of a validation failure.
|
Geometry |
BufferResultValidator.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
|
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.
|
double |
IndexedFacetDistance.getDistance(Geometry g)
Computes the distance from the base geometry to
the given 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.
|
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.
|
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 |
LineSequencer.add(Geometry geometry)
Adds a
Geometry to be sequenced. |
void |
LineMerger.add(Geometry geometry)
Adds a Geometry to be processed.
|
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 |
SnapOverlayOp.difference(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.difference(Geometry g0,
Geometry g1) |
Geometry |
SnapOverlayOp.getResultGeometry(int opCode) |
Geometry |
SnapIfNeededOverlayOp.getResultGeometry(int opCode) |
static Geometry |
SnapOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.overlayOp(Geometry g0,
Geometry g1,
int opCode) |
static Geometry |
SnapIfNeededOverlayOp.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 |
SnapOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.union(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.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 |
SnapOverlayOp.difference(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.difference(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.intersection(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.overlayOp(Geometry g0,
Geometry g1,
int opCode) |
static Geometry |
SnapIfNeededOverlayOp.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 |
SnapOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.symDifference(Geometry g0,
Geometry g1) |
static Geometry |
SnapOverlayOp.union(Geometry g0,
Geometry g1) |
static Geometry |
SnapIfNeededOverlayOp.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 |
UnaryUnionOp.union()
Gets the union of the input geometries.
|
Geometry |
UnionInteracting.union() |
Geometry |
CascadedPolygonUnion.union()
Computes the union of the input geometries.
|
Geometry |
PointGeometryUnion.union() |
static Geometry |
UnaryUnionOp.union(Collection geoms)
Computes the geometric union of a
Collection
of Geometry s. |
static Geometry |
CascadedPolygonUnion.union(Collection polys)
|
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 |
GeometryPrecisionReducer.reduce(Geometry geom) |
Geometry |
SimpleGeometryPrecisionReducer.reduce(Geometry geom)
Deprecated.
|
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 |
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.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 |
GeometryPrecisionReducer.reduce(Geometry geom) |
Geometry |
SimpleGeometryPrecisionReducer.reduce(Geometry geom)
Deprecated.
|
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 |
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.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 |
KochSnowflakeBuilder.getGeometry() |
Geometry |
SierpinskiCarpetBuilder.getGeometry() |
Modifier and Type | Field and Description |
---|---|
protected Geometry |
RandomPointsBuilder.maskPoly |
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 |
DouglasPeuckerSimplifier.getResultGeometry()
Gets the simplified geometry.
|
Geometry |
TopologyPreservingSimplifier.getResultGeometry() |
Geometry |
VWSimplifier.getResultGeometry()
Gets the simplified geometry.
|
static Geometry |
DouglasPeuckerSimplifier.simplify(Geometry geom,
double distanceTolerance)
Simplifies a geometry using a given tolerance.
|
static Geometry |
TopologyPreservingSimplifier.simplify(Geometry geom,
double distanceTolerance) |
static Geometry |
VWSimplifier.simplify(Geometry geom,
double distanceTolerance)
Simplifies a geometry using a given tolerance.
|
Modifier and Type | Method and Description |
---|---|
static Geometry |
DouglasPeuckerSimplifier.simplify(Geometry geom,
double distanceTolerance)
Simplifies a geometry using a given tolerance.
|
static Geometry |
TopologyPreservingSimplifier.simplify(Geometry geom,
double distanceTolerance) |
static Geometry |
VWSimplifier.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 |
---|---|
protected Geometry |
GeometricShapeFactory.rotate(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
static boolean |
Debug.hasSegment(Geometry geom,
Coordinate p0,
Coordinate p1) |
protected Geometry |
GeometricShapeFactory.rotate(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
LineStringSelfIntersections.getEndPoints(Geometry g) |
static Geometry |
LineStringSelfIntersections.lineStringSelfIntersections(LineString line) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
LineStringSelfIntersections.getEndPoints(Geometry g) |
static void |
PolygonUnionUsingBuffer.unionUsingBuffer(Geometry[] geom)
Deprecated.
|
Modifier and Type | Method and Description |
---|---|
Geometry |
CleanDuplicatePoints.clean(Geometry g) |
Modifier and Type | Method and Description |
---|---|
Geometry |
CleanDuplicatePoints.clean(Geometry g) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
TriangleFunctions.angleBisectors(Geometry g) |
static Geometry |
SelectionFunctions.areaGreater(Geometry a,
double minArea) |
static Geometry |
SelectionFunctions.areaZero(Geometry a) |
static Geometry |
BoundaryFunctions.boundary(Geometry g) |
static Geometry |
ConstructionFunctions.boundary(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryEndpoint(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryMod2(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryMonoValentEnd(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryMultiValentEnd(Geometry g) |
static Geometry |
BufferFunctions.buffer(Geometry g,
double distance) |
static Geometry |
BufferByUnionFunctions.bufferByChains(Geometry g,
double distance,
int maxChainSize) |
static Geometry |
BufferByUnionFunctions.bufferByComponents(Geometry g,
double distance) |
static Geometry |
BufferByUnionFunctions.bufferBySegments(Geometry g,
double distance)
Buffer polygons by buffering the individual boundary segments and
either unioning or differencing them.
|
static Geometry |
BufferFunctions.bufferCurve(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferCurveWithParams(Geometry g,
Double distance,
Integer quadrantSegments,
Integer capStyle,
Integer joinStyle,
Double mitreLimit) |
static Geometry |
BufferFunctions.bufferEach(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferLineSimplifier(Geometry g,
double distance) |
static Geometry |
TestCaseGeometryFunctions.bufferMitredJoin(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferValidated(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferValidatedGeom(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferWithParams(Geometry g,
Double distance,
Integer quadrantSegments,
Integer capStyle,
Integer joinStyle,
Double mitreLimit) |
static Geometry |
BufferFunctions.bufferWithSimplify(Geometry g,
Double distance,
Double simplifyFactor) |
static Geometry |
FunctionsUtil.buildGeometry(Geometry[] geoms) |
static Geometry |
FunctionsUtil.buildGeometry(Geometry a,
Geometry b) |
static Geometry |
FunctionsUtil.buildGeometry(List geoms,
Geometry parentGeom) |
static Geometry |
TriangleFunctions.centroid(Geometry g) |
static Geometry |
ConstructionFunctions.centroid(Geometry g) |
static Geometry |
TriangleFunctions.circumcentre(Geometry g) |
static Geometry |
OverlayFunctions.clip(Geometry a,
Geometry mask) |
static Geometry |
CreateShapeFunctions.comb(Geometry g,
int nArms) |
static Geometry |
BufferByUnionFunctions.componentBuffers(Geometry g,
double distance) |
static Geometry |
TriangulationFunctions.conformingDelaunayEdges(Geometry sites,
Geometry constraints) |
static Geometry |
TriangulationFunctions.conformingDelaunayEdgesWithTolerance(Geometry sites,
Geometry constraints,
double tol) |
static Geometry |
TriangulationFunctions.conformingDelaunayTriangles(Geometry sites,
Geometry constraints) |
static Geometry |
TriangulationFunctions.conformingDelaunayTrianglesWithTolerance(Geometry sites,
Geometry constraints,
double tol) |
static Geometry |
GeometryFunctions.convertToPolygon(Geometry g) |
static Geometry |
ConstructionFunctions.convexHull(Geometry g) |
static Geometry |
SelectionFunctions.coveredBy(Geometry a,
Geometry mask) |
static Geometry |
SelectionFunctions.covers(Geometry a,
Geometry mask) |
static Geometry |
TriangulationFunctions.delaunayEdges(Geometry geom) |
static Geometry |
TriangulationFunctions.delaunayEdgesWithTolerance(Geometry geom,
double tolerance) |
static Geometry |
TriangulationFunctions.delaunayTriangles(Geometry geom) |
static Geometry |
TriangulationFunctions.delaunayTrianglesWithTolerance(Geometry geom,
double tolerance) |
static Geometry |
TriangulationFunctions.delaunayTrianglesWithToleranceNoError(Geometry geom,
double tolerance) |
static Geometry |
DistanceFunctions.densifiedDiscreteHausdorffDistanceLine(Geometry a,
Geometry b,
double frac) |
static Geometry |
TestCaseGeometryFunctions.densify(Geometry g,
double distance) |
static Geometry |
ConstructionFunctions.densify(Geometry g,
double distance) |
static Geometry |
OverlayEnhancedPrecisionFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayEnhancedPrecisionFunctions.differenceBA(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.differenceBA(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.differenceBA(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.differenceBA(Geometry a,
Geometry b) |
static Geometry |
DistanceFunctions.discreteHausdorffDistanceLine(Geometry a,
Geometry b) |
static Geometry |
DistanceFunctions.discreteOrientedHausdorffDistanceLine(Geometry a,
Geometry b) |
static Geometry |
SelectionFunctions.disjoint(Geometry a,
Geometry mask) |
static Geometry |
LineHandlingFunctions.dissolve(Geometry geom) |
static Geometry |
DissolveFunctions.dissolve(Geometry geom) |
static Geometry |
CreateShapeFunctions.ellipse(Geometry g,
int nPts) |
static Geometry |
CreateShapeFunctions.ellipseRotate(Geometry g,
int nPts,
double ang) |
static Geometry |
GeometryFunctions.envelope(Geometry g) |
static Geometry |
LineHandlingFunctions.extractChains(Geometry g,
int maxChainSize) |
static Geometry |
LinearReferencingFunctions.extractLine(Geometry g,
double start,
double end) |
static Geometry |
LineHandlingFunctions.extractLines(Geometry g) |
static Geometry |
LinearReferencingFunctions.extractPoint(Geometry g,
double index) |
static Geometry |
LineHandlingFunctions.extractSegments(Geometry g) |
static Geometry |
ConstructionFunctions.farthestPoints(Geometry g) |
static Geometry |
NodingFunctions.findNodePoints(Geometry geom) |
static Geometry |
NodingFunctions.findSingleNodePoint(Geometry geom) |
static Geometry |
SelectionFunctions.firstNComponents(Geometry g,
int n) |
static Geometry |
CreateShapeFunctions.fontGlyph(Geometry g,
String text,
String fontName) |
static Geometry |
CreateShapeFunctions.fontGlyphMonospaced(Geometry g,
String text) |
static Geometry |
CreateShapeFunctions.fontGlyphSansSerif(Geometry g,
String text) |
static Geometry |
CreateShapeFunctions.fontGlyphSerif(Geometry g,
String text) |
static Geometry |
CreateShapeFunctions.fontGlyphSerifPointSize(Geometry g,
String text,
int pointSize) |
static Geometry |
GeometryFunctions.getCoordinates(Geometry g) |
static Geometry |
GeometryFunctions.getGeometryN(Geometry g,
int i) |
static Geometry |
GeometryFunctions.getPolygonHoleN(Geometry g,
int i) |
static Geometry |
GeometryFunctions.getPolygonHoles(Geometry geom) |
static Geometry |
GeometryFunctions.getPolygonShell(Geometry g) |
static Geometry |
CreateShapeFunctions.grid(Geometry g,
int nCells) |
static Geometry |
CreateRandomShapeFunctions.haltonPoints(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.haltonPoints57(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.haltonPointsWithBases(Geometry g,
int nPts,
int basei,
int basej) |
static Geometry |
TriangleFunctions.incentre(Geometry g) |
static Geometry |
ConstructionFunctions.interiorPoint(Geometry g) |
static Geometry |
OverlayEnhancedPrecisionFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
SelectionFunctions.intersects(Geometry a,
Geometry mask) |
static Geometry |
SelectionFunctions.invalid(Geometry a) |
static Geometry |
ValidationFunctions.invalidGeoms(Geometry g) |
static Geometry |
ValidationFunctions.invalidLocations(Geometry g)
Validates all geometries in a collection independently.
|
static Geometry |
SpatialIndexFunctions.kdTreeQuery(Geometry pts,
Geometry queryEnv,
double tolerance) |
static Geometry |
SpatialIndexFunctions.kdTreeQueryRepeated(Geometry pts,
Geometry queryEnv,
double tolerance) |
static Geometry |
CreateFractalShapeFunctions.kochSnowflake(Geometry g,
int n) |
static Geometry |
JTSFunctions.logoBuffer(Geometry g,
double distance) |
static Geometry |
JTSFunctions.logoLines(Geometry g) |
static Geometry |
ConstructionFunctions.maximumDiameter(Geometry g) |
static Geometry |
NodingFunctions.MCIndexNoding(Geometry geom) |
static Geometry |
NodingFunctions.MCIndexNodingWithPrecision(Geometry geom,
double scaleFactor) |
static Geometry |
LineHandlingFunctions.mergeLines(Geometry g) |
static Geometry |
TestCaseGeometryFunctions.minClearanceLine(Geometry g) |
static Geometry |
PrecisionFunctions.minClearanceLine(Geometry g) |
static Geometry |
PrecisionFunctions.minClearanceSimpleLine(Geometry g) |
static Geometry |
ConstructionFunctions.minimumBoundingCircle(Geometry g) |
static Geometry |
ConstructionFunctions.minimumDiameter(Geometry g) |
static Geometry |
ConstructionFunctions.minimumRectangle(Geometry g) |
static Geometry |
DistanceFunctions.nearestPoints(Geometry a,
Geometry b) |
static Geometry |
GeometryFunctions.normalize(Geometry g) |
static Geometry |
ConstructionFunctions.octagonalEnvelope(Geometry g) |
static Geometry |
OffsetCurveFunctions.offsetCurve(Geometry geom,
double distance) |
static Geometry |
PolygonOverlayFunctions.overlaySnapRounded(Geometry g1,
Geometry g2,
double precisionTol) |
static Geometry |
TriangleFunctions.perpendicularBisectors(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonize(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeAllErrors(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeCutEdges(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeDangles(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeInvalidRingLines(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizePolygonal(Geometry g) |
static Geometry |
LinearReferencingFunctions.project(Geometry g,
Geometry g2) |
static Geometry |
SpatialIndexFunctions.quadTreeQuery(Geometry geoms,
Geometry queryEnv) |
static Geometry |
CreateRandomShapeFunctions.randomLineString(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPoints(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInGrid(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInGridCircles(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInGridWithGutter(Geometry g,
int nPts,
double gutterFraction) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInPolygon(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInTriangle(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomRadialPoints(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomRectilinearWalk(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomSegments(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomSegmentsInGrid(Geometry g,
int nPts) |
static Geometry |
PrecisionFunctions.reducePrecision(Geometry geom,
double scaleFactor) |
static Geometry |
PrecisionFunctions.reducePrecisionPointwise(Geometry geom,
double scaleFactor) |
static Geometry |
AffineTransformationFunctions.reflectInX(Geometry g) |
static Geometry |
AffineTransformationFunctions.reflectInY(Geometry g) |
static Geometry |
GeometryFunctions.reverse(Geometry g) |
static Geometry |
AffineTransformationFunctions.rotate(Geometry g,
double angle) |
static Geometry |
AffineTransformationFunctions.rotateByPiMultiple(Geometry g,
double multipleOfPi) |
static Geometry |
AffineTransformationFunctions.scale(Geometry g,
double scale) |
static Geometry |
NodingFunctions.scaledNoding(Geometry geom,
double scaleFactor)
Runs a ScaledNoder on input.
|
static Geometry |
CGAlgorithmFunctions.segmentIntersection(Geometry g1,
Geometry g2) |
static Geometry |
CGAlgorithmFunctions.segmentIntersectionDD(Geometry g1,
Geometry g2) |
static Geometry |
LineHandlingFunctions.sequenceLines(Geometry g) |
static Geometry |
CreateFractalShapeFunctions.sierpinskiCarpet(Geometry g,
int n) |
static Geometry |
SimplificationFunctions.simplifyDP(Geometry g,
double distance) |
static Geometry |
SimplificationFunctions.simplifyTP(Geometry g,
double distance) |
static Geometry |
SimplificationFunctions.simplifyVW(Geometry g,
double distance) |
static Geometry |
CreateShapeFunctions.sineStar(Geometry g,
int nArms,
int nPts) |
static Geometry |
BufferFunctions.singleSidedBuffer(Geometry geom,
double distance) |
static Geometry |
BufferFunctions.singleSidedBufferCurve(Geometry geom,
double distance) |
static Geometry |
SnappingFunctions.snapAtoB(Geometry g,
Geometry g2,
double distance) |
static Geometry |
NodingFunctions.snapRoundWithPointwisePrecisionReduction(Geometry geom,
double scaleFactor)
Reduces precision pointwise, then snap-rounds.
|
static Geometry |
SnappingFunctions.snapToSelfAndClean(Geometry g,
double distance) |
static Geometry |
SortingFunctions.sortByArea(Geometry g) |
static Geometry |
SortingFunctions.sortByLength(Geometry g) |
static Geometry |
CreateShapeFunctions.squircle(Geometry g,
int nPts) |
static Geometry |
SpatialIndexFunctions.strTreeBounds(Geometry geoms) |
static Geometry |
SpatialIndexFunctions.strTreeQuery(Geometry geoms,
Geometry queryEnv) |
static Geometry |
CreateShapeFunctions.supercircle(Geometry g,
int nPts,
double pow) |
static Geometry |
CreateShapeFunctions.supercircle3(Geometry g,
int nPts) |
static Geometry |
CreateShapeFunctions.supercircle5(Geometry g,
int nPts) |
static Geometry |
CreateShapeFunctions.supercirclePoint5(Geometry g,
int nPts) |
static Geometry |
OverlayEnhancedPrecisionFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry[] |
FunctionsUtil.toGeometryArray(Geometry a,
Geometry b) |
static Geometry |
ConversionFunctions.toGeometryCollection(Geometry g,
Geometry g2) |
static Geometry |
ConversionFunctions.toLines(Geometry g1,
Geometry g2) |
static Geometry |
ConversionFunctions.toMultiPolygon(Geometry g1,
Geometry g2) |
static Geometry |
ConversionFunctions.toPoints(Geometry g1,
Geometry g2) |
static Geometry |
AffineTransformationFunctions.transformByBaseline(Geometry g,
Geometry destBaseline) |
static Geometry |
AffineTransformationFunctions.transformByVectors(Geometry g,
Geometry control) |
static Geometry |
AffineTransformationFunctions.translateCentreToOrigin(Geometry g) |
static Geometry |
AffineTransformationFunctions.translateToOrigin(Geometry g) |
static Geometry |
OverlayFunctions.unaryUnion(Geometry a) |
static Geometry |
OverlayEnhancedPrecisionFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.unionUsingGeometryCollection(Geometry a,
Geometry b) |
static Geometry |
SelectionFunctions.valid(Geometry a) |
static Geometry |
AffineTransformationFunctions.viewport(Geometry g,
Geometry gViewport) |
static Geometry |
TriangulationFunctions.voronoiDiagram(Geometry sitesGeom,
Geometry clipGeom) |
static Geometry |
TriangulationFunctions.voronoiDiagramWithData(Geometry sitesGeom,
Geometry clipGeom) |
static Geometry |
SelectionFunctions.within(Geometry a,
Geometry mask) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
TriangleFunctions.angleBisectors(Geometry g) |
static double |
GeometryFunctions.area(Geometry g) |
static Geometry |
SelectionFunctions.areaGreater(Geometry a,
double minArea) |
static Geometry |
SelectionFunctions.areaZero(Geometry a) |
static Geometry |
BoundaryFunctions.boundary(Geometry g) |
static Geometry |
ConstructionFunctions.boundary(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryEndpoint(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryMod2(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryMonoValentEnd(Geometry g) |
static Geometry |
BoundaryFunctions.boundaryMultiValentEnd(Geometry g) |
static Geometry |
BufferFunctions.buffer(Geometry g,
double distance) |
static Geometry |
BufferByUnionFunctions.bufferByChains(Geometry g,
double distance,
int maxChainSize) |
static Geometry |
BufferByUnionFunctions.bufferByComponents(Geometry g,
double distance) |
static Geometry |
BufferByUnionFunctions.bufferBySegments(Geometry g,
double distance)
Buffer polygons by buffering the individual boundary segments and
either unioning or differencing them.
|
static Geometry |
BufferFunctions.bufferCurve(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferCurveWithParams(Geometry g,
Double distance,
Integer quadrantSegments,
Integer capStyle,
Integer joinStyle,
Double mitreLimit) |
static Geometry |
BufferFunctions.bufferEach(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferLineSimplifier(Geometry g,
double distance) |
static Geometry |
TestCaseGeometryFunctions.bufferMitredJoin(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferValidated(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferValidatedGeom(Geometry g,
double distance) |
static Geometry |
BufferFunctions.bufferWithParams(Geometry g,
Double distance,
Integer quadrantSegments,
Integer capStyle,
Integer joinStyle,
Double mitreLimit) |
static Geometry |
BufferFunctions.bufferWithSimplify(Geometry g,
Double distance,
Double simplifyFactor) |
static Geometry |
FunctionsUtil.buildGeometry(Geometry[] geoms) |
static Geometry |
FunctionsUtil.buildGeometry(Geometry a,
Geometry b) |
static Geometry |
FunctionsUtil.buildGeometry(List geoms,
Geometry parentGeom) |
static Geometry |
TriangleFunctions.centroid(Geometry g) |
static Geometry |
ConstructionFunctions.centroid(Geometry g) |
static Geometry |
TriangleFunctions.circumcentre(Geometry g) |
static Geometry |
OverlayFunctions.clip(Geometry a,
Geometry mask) |
static Geometry |
CreateShapeFunctions.comb(Geometry g,
int nArms) |
static Geometry |
BufferByUnionFunctions.componentBuffers(Geometry g,
double distance) |
static Geometry |
TriangulationFunctions.conformingDelaunayEdges(Geometry sites,
Geometry constraints) |
static Geometry |
TriangulationFunctions.conformingDelaunayEdgesWithTolerance(Geometry sites,
Geometry constraints,
double tol) |
static Geometry |
TriangulationFunctions.conformingDelaunayTriangles(Geometry sites,
Geometry constraints) |
static Geometry |
TriangulationFunctions.conformingDelaunayTrianglesWithTolerance(Geometry sites,
Geometry constraints,
double tol) |
static boolean |
SpatialPredicateFunctions.contains(Geometry a,
Geometry b) |
static Geometry |
GeometryFunctions.convertToPolygon(Geometry g) |
static Geometry |
ConstructionFunctions.convexHull(Geometry g) |
static Geometry |
SelectionFunctions.coveredBy(Geometry a,
Geometry mask) |
static boolean |
SpatialPredicateFunctions.coveredBy(Geometry a,
Geometry b) |
static Geometry |
SelectionFunctions.covers(Geometry a,
Geometry mask) |
static boolean |
SpatialPredicateFunctions.covers(Geometry a,
Geometry b) |
static boolean |
SpatialPredicateFunctions.crosses(Geometry a,
Geometry b) |
static Geometry |
TriangulationFunctions.delaunayEdges(Geometry geom) |
static Geometry |
TriangulationFunctions.delaunayEdgesWithTolerance(Geometry geom,
double tolerance) |
static Geometry |
TriangulationFunctions.delaunayTriangles(Geometry geom) |
static Geometry |
TriangulationFunctions.delaunayTrianglesWithTolerance(Geometry geom,
double tolerance) |
static Geometry |
TriangulationFunctions.delaunayTrianglesWithToleranceNoError(Geometry geom,
double tolerance) |
static Geometry |
DistanceFunctions.densifiedDiscreteHausdorffDistanceLine(Geometry a,
Geometry b,
double frac) |
static Geometry |
TestCaseGeometryFunctions.densify(Geometry g,
double distance) |
static Geometry |
ConstructionFunctions.densify(Geometry g,
double distance) |
static Geometry |
OverlayEnhancedPrecisionFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.difference(Geometry a,
Geometry b) |
static Geometry |
OverlayEnhancedPrecisionFunctions.differenceBA(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.differenceBA(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.differenceBA(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.differenceBA(Geometry a,
Geometry b) |
static double |
DistanceFunctions.discreteHausdorffDistance(Geometry a,
Geometry b) |
static Geometry |
DistanceFunctions.discreteHausdorffDistanceLine(Geometry a,
Geometry b) |
static double |
DistanceFunctions.discreteOrientedHausdorffDistance(Geometry a,
Geometry b) |
static Geometry |
DistanceFunctions.discreteOrientedHausdorffDistanceLine(Geometry a,
Geometry b) |
static Geometry |
SelectionFunctions.disjoint(Geometry a,
Geometry mask) |
static boolean |
SpatialPredicateFunctions.disjoint(Geometry a,
Geometry b) |
static Geometry |
LineHandlingFunctions.dissolve(Geometry geom) |
static Geometry |
DissolveFunctions.dissolve(Geometry geom) |
static double |
DistanceFunctions.distance(Geometry a,
Geometry b) |
static Geometry |
CreateShapeFunctions.ellipse(Geometry g,
int nPts) |
static Geometry |
CreateShapeFunctions.ellipseRotate(Geometry g,
int nPts,
double ang) |
static Geometry |
GeometryFunctions.envelope(Geometry g) |
static boolean |
SpatialPredicateFunctions.equals(Geometry a,
Geometry b) |
static Geometry |
LineHandlingFunctions.extractChains(Geometry g,
int maxChainSize) |
static Geometry |
LinearReferencingFunctions.extractLine(Geometry g,
double start,
double end) |
static Geometry |
LineHandlingFunctions.extractLines(Geometry g) |
static Geometry |
LinearReferencingFunctions.extractPoint(Geometry g,
double index) |
static Geometry |
LineHandlingFunctions.extractSegments(Geometry g) |
static Geometry |
ConstructionFunctions.farthestPoints(Geometry g) |
static Geometry |
NodingFunctions.findNodePoints(Geometry geom) |
static Geometry |
NodingFunctions.findSingleNodePoint(Geometry geom) |
static Geometry |
SelectionFunctions.firstNComponents(Geometry g,
int n) |
static Geometry |
CreateShapeFunctions.fontGlyph(Geometry g,
String text,
String fontName) |
static Geometry |
CreateShapeFunctions.fontGlyphMonospaced(Geometry g,
String text) |
static Geometry |
CreateShapeFunctions.fontGlyphSansSerif(Geometry g,
String text) |
static Geometry |
CreateShapeFunctions.fontGlyphSerif(Geometry g,
String text) |
static Geometry |
CreateShapeFunctions.fontGlyphSerifPointSize(Geometry g,
String text,
int pointSize) |
static Geometry |
GeometryFunctions.getCoordinates(Geometry g) |
static Envelope |
FunctionsUtil.getEnvelopeOrDefault(Geometry g) |
static GeometryFactory |
FunctionsUtil.getFactoryOrDefault(Geometry g) |
static GeometryFactory |
FunctionsUtil.getFactoryOrDefault(Geometry g1,
Geometry g2) |
static Geometry |
GeometryFunctions.getGeometryN(Geometry g,
int i) |
static Geometry |
GeometryFunctions.getPolygonHoleN(Geometry g,
int i) |
static Geometry |
GeometryFunctions.getPolygonHoles(Geometry geom) |
static Geometry |
GeometryFunctions.getPolygonShell(Geometry g) |
static Geometry |
CreateShapeFunctions.grid(Geometry g,
int nCells) |
static Geometry |
CreateRandomShapeFunctions.haltonPoints(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.haltonPoints57(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.haltonPointsWithBases(Geometry g,
int nPts,
int basei,
int basej) |
static Geometry |
TriangleFunctions.incentre(Geometry g) |
static int |
NodingFunctions.interiorIntersectionCount(Geometry geom) |
static Geometry |
ConstructionFunctions.interiorPoint(Geometry g) |
static Geometry |
OverlayEnhancedPrecisionFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.intersection(Geometry a,
Geometry b) |
static Geometry |
SelectionFunctions.intersects(Geometry a,
Geometry mask) |
static boolean |
SpatialPredicateFunctions.intersects(Geometry a,
Geometry b) |
static boolean |
PreparedGeometryFunctions.intersects(Geometry g1,
Geometry g2) |
static Geometry |
SelectionFunctions.invalid(Geometry a) |
static Geometry |
ValidationFunctions.invalidGeoms(Geometry g) |
static Geometry |
ValidationFunctions.invalidLocations(Geometry g)
Validates all geometries in a collection independently.
|
Object |
StaticMethodGeometryFunction.invoke(Geometry g,
Object[] arg) |
abstract Object |
BaseGeometryFunction.invoke(Geometry geom,
Object[] args) |
Object |
GeometryFunction.invoke(Geometry geom,
Object[] args)
Invokes this function.
|
static boolean |
GeometryFunctions.isCCW(Geometry g) |
static boolean |
GeometryFunctions.isClosed(Geometry g) |
static boolean |
NodingFunctions.isNodingValid(Geometry geom) |
static boolean |
GeometryFunctions.isRectangle(Geometry g) |
static boolean |
GeometryFunctions.isSimple(Geometry g) |
static boolean |
GeometryFunctions.isValid(Geometry g) |
static boolean |
DistanceFunctions.isWithinDistance(Geometry a,
Geometry b,
double dist) |
static String |
JTSFunctions.jtsVersion(Geometry g) |
static Geometry |
SpatialIndexFunctions.kdTreeQuery(Geometry pts,
Geometry queryEnv,
double tolerance) |
static Geometry |
SpatialIndexFunctions.kdTreeQueryRepeated(Geometry pts,
Geometry queryEnv,
double tolerance) |
static Geometry |
CreateFractalShapeFunctions.kochSnowflake(Geometry g,
int n) |
static double |
GeometryFunctions.length(Geometry g) |
static Geometry |
JTSFunctions.logoBuffer(Geometry g,
double distance) |
static Geometry |
JTSFunctions.logoLines(Geometry g) |
static Geometry |
ConstructionFunctions.maximumDiameter(Geometry g) |
static double |
ConstructionFunctions.maximumDiameterLength(Geometry g) |
static Geometry |
NodingFunctions.MCIndexNoding(Geometry geom) |
static Geometry |
NodingFunctions.MCIndexNodingWithPrecision(Geometry geom,
double scaleFactor) |
static Geometry |
LineHandlingFunctions.mergeLines(Geometry g) |
static double |
TestCaseGeometryFunctions.minClearance(Geometry g) |
static double |
PrecisionFunctions.minClearance(Geometry g) |
static Geometry |
TestCaseGeometryFunctions.minClearanceLine(Geometry g) |
static Geometry |
PrecisionFunctions.minClearanceLine(Geometry g) |
static double |
PrecisionFunctions.minClearanceSimple(Geometry g) |
static Geometry |
PrecisionFunctions.minClearanceSimpleLine(Geometry g) |
static Geometry |
ConstructionFunctions.minimumBoundingCircle(Geometry g) |
static Geometry |
ConstructionFunctions.minimumDiameter(Geometry g) |
static double |
ConstructionFunctions.minimumDiameterLength(Geometry g) |
static Geometry |
ConstructionFunctions.minimumRectangle(Geometry g) |
static Geometry |
DistanceFunctions.nearestPoints(Geometry a,
Geometry b) |
static Geometry |
GeometryFunctions.normalize(Geometry g) |
static Geometry |
ConstructionFunctions.octagonalEnvelope(Geometry g) |
static Geometry |
OffsetCurveFunctions.offsetCurve(Geometry geom,
double distance) |
static int |
CGAlgorithmFunctions.orientationIndex(Geometry segment,
Geometry ptGeom) |
static int |
CGAlgorithmFunctions.orientationIndexDD(Geometry segment,
Geometry ptGeom) |
static boolean |
SpatialPredicateFunctions.overlaps(Geometry a,
Geometry b) |
static Geometry |
PolygonOverlayFunctions.overlaySnapRounded(Geometry g1,
Geometry g2,
double precisionTol) |
static Geometry |
TriangleFunctions.perpendicularBisectors(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonize(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeAllErrors(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeCutEdges(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeDangles(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizeInvalidRingLines(Geometry g) |
static Geometry |
PolygonizeFunctions.polygonizePolygonal(Geometry g) |
static boolean |
PreparedGeometryFunctions.preparedIntersects(Geometry g1,
Geometry g2) |
static Geometry |
LinearReferencingFunctions.project(Geometry g,
Geometry g2) |
static double |
LinearReferencingFunctions.projectIndex(Geometry g,
Geometry g2) |
static Geometry |
SpatialIndexFunctions.quadTreeQuery(Geometry geoms,
Geometry queryEnv) |
static Geometry |
CreateRandomShapeFunctions.randomLineString(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPoints(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInGrid(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInGridCircles(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInGridWithGutter(Geometry g,
int nPts,
double gutterFraction) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInPolygon(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomPointsInTriangle(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomRadialPoints(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomRectilinearWalk(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomSegments(Geometry g,
int nPts) |
static Geometry |
CreateRandomShapeFunctions.randomSegmentsInGrid(Geometry g,
int nPts) |
static Geometry |
PrecisionFunctions.reducePrecision(Geometry geom,
double scaleFactor) |
static Geometry |
PrecisionFunctions.reducePrecisionPointwise(Geometry geom,
double scaleFactor) |
static Geometry |
AffineTransformationFunctions.reflectInX(Geometry g) |
static Geometry |
AffineTransformationFunctions.reflectInY(Geometry g) |
static String |
SpatialPredicateFunctions.relate(Geometry a,
Geometry b) |
static Geometry |
GeometryFunctions.reverse(Geometry g) |
static Geometry |
AffineTransformationFunctions.rotate(Geometry g,
double angle) |
static Geometry |
AffineTransformationFunctions.rotateByPiMultiple(Geometry g,
double multipleOfPi) |
static Geometry |
AffineTransformationFunctions.scale(Geometry g,
double scale) |
static Geometry |
NodingFunctions.scaledNoding(Geometry geom,
double scaleFactor)
Runs a ScaledNoder on input.
|
static Geometry |
CGAlgorithmFunctions.segmentIntersection(Geometry g1,
Geometry g2) |
static Geometry |
CGAlgorithmFunctions.segmentIntersectionDD(Geometry g1,
Geometry g2) |
static boolean |
CGAlgorithmFunctions.segmentIntersects(Geometry g1,
Geometry g2) |
static Geometry |
LineHandlingFunctions.sequenceLines(Geometry g) |
static void |
FunctionsUtil.showIndicator(Geometry geom) |
static Geometry |
CreateFractalShapeFunctions.sierpinskiCarpet(Geometry g,
int n) |
static Geometry |
SimplificationFunctions.simplifyDP(Geometry g,
double distance) |
static Geometry |
SimplificationFunctions.simplifyTP(Geometry g,
double distance) |
static Geometry |
SimplificationFunctions.simplifyVW(Geometry g,
double distance) |
static Geometry |
CreateShapeFunctions.sineStar(Geometry g,
int nArms,
int nPts) |
static Geometry |
BufferFunctions.singleSidedBuffer(Geometry geom,
double distance) |
static Geometry |
BufferFunctions.singleSidedBufferCurve(Geometry geom,
double distance) |
static Geometry |
SnappingFunctions.snapAtoB(Geometry g,
Geometry g2,
double distance) |
static Geometry |
NodingFunctions.snapRoundWithPointwisePrecisionReduction(Geometry geom,
double scaleFactor)
Reduces precision pointwise, then snap-rounds.
|
static Geometry |
SnappingFunctions.snapToSelfAndClean(Geometry g,
double distance) |
static Geometry |
SortingFunctions.sortByArea(Geometry g) |
static Geometry |
SortingFunctions.sortByLength(Geometry g) |
static Geometry |
CreateShapeFunctions.squircle(Geometry g,
int nPts) |
static Geometry |
SpatialIndexFunctions.strTreeBounds(Geometry geoms) |
static Geometry |
SpatialIndexFunctions.strTreeQuery(Geometry geoms,
Geometry queryEnv) |
static Geometry |
CreateShapeFunctions.supercircle(Geometry g,
int nPts,
double pow) |
static Geometry |
CreateShapeFunctions.supercircle3(Geometry g,
int nPts) |
static Geometry |
CreateShapeFunctions.supercircle5(Geometry g,
int nPts) |
static Geometry |
CreateShapeFunctions.supercirclePoint5(Geometry g,
int nPts) |
static Geometry |
OverlayEnhancedPrecisionFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.symDifference(Geometry a,
Geometry b) |
static Geometry[] |
FunctionsUtil.toGeometryArray(Geometry a,
Geometry b) |
static Geometry |
ConversionFunctions.toGeometryCollection(Geometry g,
Geometry g2) |
static Geometry |
ConversionFunctions.toLines(Geometry g1,
Geometry g2) |
static Geometry |
ConversionFunctions.toMultiPolygon(Geometry g1,
Geometry g2) |
static Geometry |
ConversionFunctions.toPoints(Geometry g1,
Geometry g2) |
static boolean |
SpatialPredicateFunctions.touches(Geometry a,
Geometry b) |
static Geometry |
AffineTransformationFunctions.transformByBaseline(Geometry g,
Geometry destBaseline) |
static Geometry |
AffineTransformationFunctions.transformByVectors(Geometry g,
Geometry control) |
static Geometry |
AffineTransformationFunctions.translateCentreToOrigin(Geometry g) |
static Geometry |
AffineTransformationFunctions.translateToOrigin(Geometry g) |
static Geometry |
OverlayFunctions.unaryUnion(Geometry a) |
static Geometry |
OverlayEnhancedPrecisionFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayCommonBitsRemovedFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayNoSnapFunctions.union(Geometry a,
Geometry b) |
static Geometry |
OverlayFunctions.unionUsingGeometryCollection(Geometry a,
Geometry b) |
static Geometry |
SelectionFunctions.valid(Geometry a) |
static Geometry |
AffineTransformationFunctions.viewport(Geometry g,
Geometry gViewport) |
static Geometry |
TriangulationFunctions.voronoiDiagram(Geometry sitesGeom,
Geometry clipGeom) |
static Geometry |
TriangulationFunctions.voronoiDiagramWithData(Geometry sitesGeom,
Geometry clipGeom) |
static Geometry |
SelectionFunctions.within(Geometry a,
Geometry mask) |
static boolean |
SpatialPredicateFunctions.within(Geometry a,
Geometry b) |
static String |
WriterFunctions.writeGML(Geometry geom) |
static String |
WriterFunctions.writeKML(Geometry geom) |
static String |
WriterFunctions.writeOra(Geometry g) |
static String |
WriterFunctions.writeWKB(Geometry g) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
OverlayValidatedGeometryOperation.invokeGeometryOverlayMethod(int opCode,
Geometry g0,
Geometry g1) |
Modifier and Type | Method and Description |
---|---|
static double |
OverlayValidatedGeometryOperation.areaDiff(Geometry g0,
Geometry g1) |
Result |
BufferValidatedGeometryOperation.invoke(String opName,
Geometry geometry,
Object[] args)
Invokes the named operation
|
Result |
TeeGeometryOperation.invoke(String opName,
Geometry geometry,
Object[] args)
Invokes the named operation
|
Result |
GeometryMethodOperation.invoke(String opName,
Geometry geometry,
Object[] args) |
Result |
LoggingGeometryOperation.invoke(String opName,
Geometry geometry,
Object[] args) |
Result |
GeometryFunctionOperation.invoke(String opName,
Geometry geometry,
Object[] args) |
Result |
GeometryOperation.invoke(String opName,
Geometry geometry,
Object[] args)
Invokes an operation on a
Geometry . |
Result |
PreparedGeometryOperation.invoke(String opName,
Geometry geometry,
Object[] args)
Invokes the named operation
|
Result |
OverlayValidatedGeometryOperation.invoke(String opName,
Geometry geometry,
Object[] args)
Invokes the named operation
|
static Geometry |
OverlayValidatedGeometryOperation.invokeGeometryOverlayMethod(int opCode,
Geometry g0,
Geometry g1) |
Result |
OverlayValidatedGeometryOperation.invokeValidatedOverlayOp(int opCode,
Geometry g0,
Object[] args)
Invokes an overlay op, optionally using snapping,
and optionally validating the result.
|
boolean |
GeometryMatcher.match(Geometry a,
Geometry b) |
boolean |
NormalizedGeometryMatcher.match(Geometry a,
Geometry b) |
protected abstract void |
TeeGeometryOperation.runTeeOp(String opName,
Geometry geometry,
Object[] args) |
protected void |
PreparedGeometryTeeOperation.runTeeOp(String opName,
Geometry geometry,
Object[] args) |
Modifier and Type | Method and Description |
---|---|
Geometry |
Testable.getExpectedBoundary() |
Geometry |
TestCase.getExpectedBoundary() |
Geometry |
Testable.getExpectedConvexHull() |
Geometry |
TestCase.getExpectedConvexHull() |
Geometry |
Testable.getExpectedDifference() |
Geometry |
TestCase.getExpectedDifference() |
Geometry |
Testable.getExpectedIntersection() |
Geometry |
TestCase.getExpectedIntersection() |
Geometry |
Testable.getExpectedSymDifference() |
Geometry |
TestCase.getExpectedSymDifference() |
Geometry |
Testable.getExpectedUnion() |
Geometry |
TestCase.getExpectedUnion() |
Geometry[] |
TestCase.getGeometries() |
Geometry |
Testable.getGeometry(int index) |
Geometry |
TestCase.getGeometry(int index) |
Modifier and Type | Method and Description |
---|---|
void |
Testable.setExpectedBoundary(Geometry boundary) |
void |
TestCase.setExpectedBoundary(Geometry expectedBoundary) |
void |
Testable.setExpectedCentroid(Geometry expectedCentroid) |
void |
TestCase.setExpectedCentroid(Geometry expectedCentroid) |
void |
Testable.setExpectedConvexHull(Geometry expectedConvexHull) |
void |
TestCase.setExpectedConvexHull(Geometry expectedConvexHull) |
void |
Testable.setExpectedDifference(Geometry expectedDifference) |
void |
TestCase.setExpectedDifference(Geometry expectedDifference) |
void |
Testable.setExpectedIntersection(Geometry expectedIntersection) |
void |
TestCase.setExpectedIntersection(Geometry expectedIntersection) |
void |
Testable.setExpectedSymDifference(Geometry expectedSymDifference) |
void |
TestCase.setExpectedSymDifference(Geometry expectedSymDifference) |
void |
Testable.setExpectedUnion(Geometry expectedUnion) |
void |
TestCase.setExpectedUnion(Geometry expectedUnion) |
void |
Testable.setGeometry(int index,
Geometry g) |
void |
TestCase.setGeometry(int index,
Geometry g) |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryTreePanel.getSelectedGeometry() |
Modifier and Type | Method and Description |
---|---|
void |
GeometryEditPanel.flash(Geometry g) |
void |
GeometryTreePanel.populate(Geometry geom,
int source) |
void |
GeometryInspectorDialog.setGeometry(String tag,
Geometry geometry) |
void |
InspectorPanel.setGeometry(String tag,
Geometry a,
int source) |
void |
WKTPanel.setText(Geometry g,
int geomIndex) |
void |
GeometryEditPanel.zoom(Geometry geom) |
Constructor and Description |
---|
GeometryTreeModel(Geometry geom,
int source) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
JTSTestBuilderController.getGeometryA() |
static Geometry |
JTSTestBuilderController.getGeometryB() |
Modifier and Type | Method and Description |
---|---|
static void |
JTSTestBuilderController.addTestCase(Geometry[] geom,
String name) |
static void |
JTSTestBuilderController.extractComponentsToTestCase(Geometry aoi) |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryCombiner.addLineString(Geometry orig,
Coordinate[] pts) |
Geometry |
GeometryCombiner.addPoint(Geometry orig,
Coordinate pt) |
Geometry |
GeometryCombiner.addPolygonRing(Geometry orig,
Coordinate[] pts) |
Geometry |
GeometryCombiner.combine(Geometry orig,
Geometry geom) |
Geometry |
GeometryLocation.delete() |
static Geometry |
GeometryBoxDeleter.delete(Geometry geom,
Envelope env) |
static Geometry |
GeometryVertexDeleter.delete(Geometry geom,
LineString line,
int vertexIndex) |
Geometry |
GeometryLocation.getComponent() |
Geometry |
GeometryLocation.insert() |
static Geometry |
GeometryVertexInserter.insert(Geometry geom,
LineString line,
int segIndex,
Coordinate newVertex) |
static Geometry |
GeometryVertexMover.move(Geometry geom,
Coordinate fromLoc,
Coordinate toLoc) |
static Geometry |
GeometryCombiner.replace(Geometry parent,
Geometry original,
Geometry replacement) |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryCombiner.addLineString(Geometry orig,
Coordinate[] pts) |
Geometry |
GeometryCombiner.addPoint(Geometry orig,
Coordinate pt) |
Geometry |
GeometryCombiner.addPolygonRing(Geometry orig,
Coordinate[] pts) |
Geometry |
GeometryCombiner.combine(Geometry orig,
Geometry geom) |
static Geometry |
GeometryBoxDeleter.delete(Geometry geom,
Envelope env) |
static Geometry |
GeometryVertexDeleter.delete(Geometry geom,
LineString line,
int vertexIndex) |
static List |
GeometryCombiner.extractElements(Geometry geom,
boolean skipEmpty) |
static Coordinate |
NearestPointFinder.findNearestPoint(Geometry geom,
Coordinate pt,
double tolerance) |
static Coordinate[] |
AdjacentVertexFinder.findVertices(Geometry geom,
Coordinate testPt) |
List |
ComponentLocater.getComponents(Geometry aoi) |
static Geometry |
GeometryVertexInserter.insert(Geometry geom,
LineString line,
int segIndex,
Coordinate newVertex) |
static GeometryLocation |
GeometryPointLocater.locateNonVertexPoint(Geometry geom,
Coordinate testPt,
double tolerance) |
static GeometryLocation |
GeometryPointLocater.locateVertex(Geometry geom,
Coordinate testPt,
double tolerance) |
static Coordinate |
VertexLocater.locateVertex(Geometry geom,
Coordinate testPt,
double tolerance) |
static String |
GeometryUtil.metricsSummary(Geometry g) |
static Geometry |
GeometryVertexMover.move(Geometry geom,
Coordinate fromLoc,
Coordinate toLoc) |
static Geometry |
GeometryCombiner.replace(Geometry parent,
Geometry original,
Geometry replacement) |
static String |
GeometryUtil.structureSummary(Geometry g) |
Constructor and Description |
---|
AdjacentVertexFinder(Geometry geom) |
ComponentLocater(Geometry parentGeom) |
FacetLocater(Geometry parentGeom) |
GeometryLocation(Geometry parent,
Geometry component,
int[] componentPath) |
GeometryLocation(Geometry parent,
Geometry component,
int[] componentPath,
int segmentIndex,
boolean isVertex,
Coordinate pt) |
GeometryLocation(Geometry parent,
Geometry component,
int segmentIndex,
boolean isVertex,
Coordinate pt) |
GeometryLocation(Geometry parent,
Geometry component,
int index,
Coordinate pt) |
GeometryPointLocater(Geometry geom) |
NearestPointFinder(Geometry geom) |
VertexLocater(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
Geometry |
Shapefile.next()
Returns the next geometry in the shapefile stream
|
Geometry |
PolygonHandler.read(EndianDataInputStream file,
GeometryFactory geometryFactory,
int contentLength) |
Geometry |
MultiLineHandler.read(EndianDataInputStream file,
GeometryFactory geometryFactory,
int contentLength) |
Geometry |
MultiPointHandler.read(EndianDataInputStream file,
GeometryFactory geometryFactory,
int contentLength) |
Geometry |
ShapeHandler.read(EndianDataInputStream file,
GeometryFactory geometryFactory,
int contentLength) |
Geometry |
PointHandler.read(EndianDataInputStream file,
GeometryFactory geometryFactory,
int contentLength) |
Modifier and Type | Method and Description |
---|---|
int |
PolygonHandler.getLength(Geometry geometry) |
int |
MultiLineHandler.getLength(Geometry geometry) |
int |
MultiPointHandler.getLength(Geometry geometry)
Calcuates the record length of this object.
|
int |
ShapeHandler.getLength(Geometry geometry) |
int |
PointHandler.getLength(Geometry geometry)
Calcuates the record length of this object.
|
static ShapeHandler |
Shapefile.getShapeHandler(Geometry geom,
int ShapeFileDimentions) |
static int |
Shapefile.getShapeType(Geometry geom,
int coordDimension) |
Modifier and Type | Method and Description |
---|---|
Geometry |
LayerList.getComponent(Coordinate pt,
double tolerance) |
Geometry[] |
LayerList.getComponents(Geometry aoi) |
Geometry |
TestRunnerTestCaseAdapter.getExpectedBoundary() |
Geometry |
TestCaseEdit.getExpectedBoundary() |
Geometry |
TestRunnerTestCaseAdapter.getExpectedConvexHull() |
Geometry |
TestCaseEdit.getExpectedConvexHull() |
Geometry |
TestRunnerTestCaseAdapter.getExpectedDifference() |
Geometry |
TestCaseEdit.getExpectedDifference() |
Geometry |
TestRunnerTestCaseAdapter.getExpectedIntersection() |
Geometry |
TestCaseEdit.getExpectedIntersection() |
Geometry |
TestRunnerTestCaseAdapter.getExpectedSymDifference() |
Geometry |
TestCaseEdit.getExpectedSymDifference() |
Geometry |
TestRunnerTestCaseAdapter.getExpectedUnion() |
Geometry |
TestCaseEdit.getExpectedUnion() |
Geometry[] |
TestCaseEdit.getGeometries() |
Geometry |
ResultGeometryContainer.getGeometry() |
Geometry |
GeometryContainer.getGeometry() |
Geometry |
IndexedGeometryContainer.getGeometry() |
Geometry |
GeometryEditModel.getGeometry() |
Geometry |
Layer.getGeometry() |
Geometry |
StaticGeometryContainer.getGeometry() |
Geometry |
TestRunnerTestCaseAdapter.getGeometry(int index) |
Geometry |
TestCaseEdit.getGeometry(int i) |
Geometry |
GeometryEditModel.getGeometry(int i) |
Geometry |
TestCaseEdit.getResult() |
Geometry |
GeometryEditModel.getResult() |
Geometry |
GeometryStretcherView.getStretchedGeometry(int index) |
Geometry |
TestBuilderModel.readGeometryText(String geomStr) |
Geometry |
TestRunnerTestCaseAdapter.toGeometry(Test test) |
Modifier and Type | Method and Description |
---|---|
void |
TestBuilderModel.addCase(Geometry[] geoms) |
void |
TestBuilderModel.addCase(Geometry[] geoms,
String name) |
Geometry[] |
LayerList.getComponents(Geometry aoi) |
String |
TestBuilderModel.getResultDisplayString(Geometry g) |
String |
XMLTestWriter.getTestXML(Geometry geometry,
String opName,
String[] arguments) |
static String |
GeometryEditModel.getText(Geometry geom,
int textType) |
void |
TestRunnerTestCaseAdapter.setExpectedBoundary(Geometry expectedBoundary) |
void |
TestCaseEdit.setExpectedBoundary(Geometry expectedBoundary) |
void |
TestRunnerTestCaseAdapter.setExpectedCentroid(Geometry expected) |
void |
TestCaseEdit.setExpectedCentroid(Geometry expectedCentroid) |
void |
TestRunnerTestCaseAdapter.setExpectedConvexHull(Geometry expectedConvexHull) |
void |
TestCaseEdit.setExpectedConvexHull(Geometry expectedConvexHull) |
void |
TestRunnerTestCaseAdapter.setExpectedDifference(Geometry expectedDifference) |
void |
TestCaseEdit.setExpectedDifference(Geometry expectedDifference) |
void |
TestRunnerTestCaseAdapter.setExpectedIntersection(Geometry expectedIntersection) |
void |
TestCaseEdit.setExpectedIntersection(Geometry expectedIntersection) |
void |
TestRunnerTestCaseAdapter.setExpectedSymDifference(Geometry expectedSymDifference) |
void |
TestCaseEdit.setExpectedSymDifference(Geometry expectedSymDifference) |
void |
TestRunnerTestCaseAdapter.setExpectedUnion(Geometry expectedUnion) |
void |
TestCaseEdit.setExpectedUnion(Geometry expectedUnion) |
void |
GeometryEditModel.setGeometry(Geometry g) |
void |
TestRunnerTestCaseAdapter.setGeometry(int index,
Geometry g) |
void |
TestCaseEdit.setGeometry(int i,
Geometry geom) |
void |
GeometryEditModel.setGeometry(int i,
Geometry g) |
void |
TestCaseEdit.setResult(Geometry geom) |
static String |
GeometryEditModel.toStringVeryLarge(Geometry g) |
Constructor and Description |
---|
GeometryTransferable(Geometry geom) |
GeometryTransferable(Geometry geom,
boolean isFormatted) |
StaticGeometryContainer(Geometry geometry) |
TestCaseEdit(Geometry[] geom) |
TestCaseEdit(Geometry[] geom,
String name) |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryVerticesMover.move() |
static Geometry |
GeometryVerticesMover.move(Geometry geom,
Map moves) |
Geometry[] |
TopologyStretcher.stretch(double nearnessTol,
double stretchDistance) |
Geometry[] |
TopologyStretcher.stretch(double nearnessTol,
double stretchDistance,
Envelope mask) |
Modifier and Type | Method and Description |
---|---|
static Geometry |
GeometryVerticesMover.move(Geometry geom,
Map moves) |
Constructor and Description |
---|
GeometryVerticesMover(Geometry geom,
Map moves) |
TopologyStretcher(Geometry g) |
TopologyStretcher(Geometry g1,
Geometry g2) |
Modifier and Type | Method and Description |
---|---|
String |
GeometryLocationsWriter.OLDwriteLocation(Geometry geom,
Coordinate p,
double tolerance) |
String |
GeometryLocationsWriter.writeComponentLocation(Geometry geom,
Coordinate p,
double tolerance) |
String |
GeometryLocationsWriter.writeFacetLocation(Geometry geom,
Coordinate p,
double tolerance) |
Modifier and Type | Field and Description |
---|---|
static Geometry |
OperationMonitorManager.indicator |
Modifier and Type | Method and Description |
---|---|
static void |
GeometryPainter.paint(Geometry geometry,
Viewport viewport,
Graphics2D g,
Color lineColor,
Color fillColor)
Paints a geometry onto a graphics context,
using a given Viewport.
|
static void |
GeometryPainter.paint(Geometry geometry,
Viewport viewport,
Graphics2D g,
Color lineColor,
Color fillColor,
Stroke stroke) |
static void |
GeometryPainter.paint(Graphics2D g,
Viewport viewport,
Geometry geometry,
Style style) |
Modifier and Type | Method and Description |
---|---|
void |
VertexStyle.paint(Geometry geom,
Viewport viewport,
Graphics2D g) |
void |
DataLabelStyle.paint(Geometry geom,
Viewport viewport,
Graphics2D g2d) |
void |
Style.paint(Geometry geom,
Viewport viewport,
Graphics2D g) |
void |
StyleList.paint(Geometry geom,
Viewport viewport,
Graphics2D g) |
void |
LineStringStyle.paint(Geometry geom,
Viewport viewport,
Graphics2D g) |
void |
BasicStyle.paint(Geometry geom,
Viewport viewport,
Graphics2D g) |
void |
ComponentStyle.paint(Geometry geom,
Viewport viewport,
Graphics2D g) |
protected abstract void |
ComponentStyle.paintComponent(Geometry geom,
Viewport viewport,
Graphics2D graphics) |
Modifier and Type | Method and Description |
---|---|
protected Geometry |
BoxBandTool.getBox() |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeometryResult.getGeometry() |
Geometry |
TestCase.getGeometryA() |
Geometry |
TestCase.getGeometryB() |
Modifier and Type | Method and Description |
---|---|
boolean |
BufferResultMatcher.isBoundaryHausdorffDistanceInTolerance(Geometry actualBuffer,
Geometry expectedBuffer,
double distance) |
boolean |
BufferResultMatcher.isBufferResultMatch(Geometry actualBuffer,
Geometry expectedBuffer,
double distance) |
boolean |
EqualityResultMatcher.isMatch(Geometry geom,
String opName,
Object[] args,
Result actualResult,
Result expectedResult,
double tolerance)
Tests whether the two results are equal within the given
tolerance.
|
boolean |
ResultMatcher.isMatch(Geometry geom,
String opName,
Object[] args,
Result actualResult,
Result expectedResult,
double tolerance)
Tests whether the actual and expected results match well
enough for the test to be considered as passed.
|
boolean |
BufferResultMatcher.isMatch(Geometry geom,
String opName,
Object[] args,
Result actualResult,
Result expectedResult,
double tolerance)
Tests whether the two results are equal within the given
tolerance.
|
boolean |
NullResultMatcher.isMatch(Geometry geom,
String opName,
Object[] args,
Result actualResult,
Result expectedResult,
double tolerance)
Always reports a match.
|
boolean |
BufferResultMatcher.isSymDiffAreaInTolerance(Geometry actualBuffer,
Geometry expectedBuffer) |
void |
TestCase.setGeometryA(Geometry a) |
void |
TestCase.setGeometryB(Geometry b) |
Constructor and Description |
---|
GeometryResult(Geometry geometry) |
TestCase(String description,
Geometry a,
Geometry b,
File aWktFile,
File bWktFile,
TestRun testRun,
int caseIndex,
int lineNumber)
Creates a TestCase with the given description.
|
Modifier and Type | Method and Description |
---|---|
static void |
GeometryDataUtil.setComponentDataToIndex(Geometry geom) |
Modifier and Type | Method and Description |
---|---|
Geometry |
GeoJsonMultiReader.read(String s) |
Geometry |
WKTOrWKBReader.read(String geomStr) |
Geometry |
MultiFormatReader.read(String geomStr) |
static Geometry |
IOUtil.readFile(String filename,
GeometryFactory geomFact) |
static Geometry |
IOUtil.readGeoJSONString(String s,
GeometryFactory geomFact) |
static Geometry |
IOUtil.readGMLString(String gml,
GeometryFactory geomFact) |
static Geometry |
IOUtil.readWKBHexString(String wkb,
GeometryFactory geomFact) |
static Geometry |
IOUtil.readWKTString(String wkt,
GeometryFactory geomFact)
Reads one or more WKT geometries from a string.
|
Modifier and Type | Method and Description |
---|---|
String |
SVGWriter.write(Geometry geometry)
Converts a
Geometry to its Well-known Text representation. |
void |
SVGWriter.write(Geometry geometry,
Writer writer)
Converts a
Geometry to its Well-known Text representation. |
String |
SVGWriter.writeFormatted(Geometry geometry)
Same as
write , but with newlines and spaces to make the
well-known text more readable. |
void |
SVGWriter.writeFormatted(Geometry geometry,
Writer writer)
Same as
write , but with newlines and spaces to make the
well-known text more readable. |
Copyright © 2017. All Rights Reserved.