Uses of Class
org.locationtech.jts.geom.Geometry
Packages that use Geometry
Package
Description
Contains classes and interfaces implementing fundamental computational geometry algorithms.
Classes to compute distance metrics between geometries.
Classes to determine the topological location of points in geometries.
Classes to compute matching metrics between geometries.
Classes to perform conversions from Java2D shape objects.
Classes to perform densification on geometries.
Contains the
Geometry
interface hierarchy and supporting classes.Classes to perform optimized geometric operations on suitably prepared geometries.
Provides classes that parse and modify Geometry objects.
Contains classes that implement topology graphs.
Contains the interfaces for converting JTS objects to and from other formats.
Classes to read and write the GML2 geometry format.
Contains classes and interfaces implementing linear referencing on linear geometries
Classes to compute nodings for arrangements of line segments and line segment sequences.
Provides classes for implementing operations on geometries
Provides classes for computing buffers of geometries
Classes to perform validation of the results of buffer operations.
Provides classes for computing the distance between geometries
Classes to perform line merging.
Contains classes that perform a topological overlay to compute boolean spatial functions.
Classes to perform snapping on geometries to prepare them for overlay operations.
Classes to validate the results of overlay operations.
An API for polygonizing sets of lines.
Classes which implement topological predicates optimized for particular kinds of geometries.
Contains classes to implement the computation of the spatial relationships of
Geometry
s.Classes to perform efficent unioning of collections of geometries.
Provides classes for testing the validity of geometries.
Provides classes for analyzing and
manipulating the precision of Geometries.
Classes which implement algorithms for simplifying or generalizing geometries.
Classes to compute Delaunay triangulations.
Classes to implement a topological subdivision of quadeges, to support creating triangulations
and Voronoi diagrams.
Contains support classes for the Java Topology Suite.
-
Uses of Geometry in org.locationtech.jts.algorithm
Fields in org.locationtech.jts.algorithm declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
MinimumBoundingCircle.input
private final Geometry
MinimumDiameter.inputGeom
Methods in org.locationtech.jts.algorithm that return GeometryModifier and TypeMethodDescriptionMinimumBoundingCircle.getCircle()
Gets a geometry which represents the Minimum Bounding Circle.ConvexHull.getConvexHull()
Returns aGeometry
that represents the convex hull of the input geometry.MinimumBoundingCircle.getDiameter()
Gets a geometry representing the diameter of the computed Minimum Bounding Circle.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 geometryMinimumDiameter.getMinimumRectangle()
Gets the minimum rectangularPolygon
which encloses the input geometry.static Geometry
MinimumDiameter.getMinimumRectangle
(Geometry geom) Gets the minimum rectangle enclosing a geometry.private Geometry
ConvexHull.lineOrPolygon
(Coordinate[] coordinates) private Geometry
InteriorPointArea.widestGeometry
(Geometry geometry) private Geometry
InteriorPointArea.widestGeometry
(GeometryCollection gc) Methods in org.locationtech.jts.algorithm with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
Adds a Geometry to the centroid total.private void
Tests the interior vertices (if any) defined by an areal Geometry for the best inside point.private void
Tests the point(s) defined by a Geometry for the best inside point.private void
InteriorPointLine.addEndpoints
(Geometry geom) Tests the endpoint vertices defined by a linear Geometry for the best inside point.private void
InteriorPointLine.addInterior
(Geometry geom) Tests the interior vertices (if any) defined by a linear Geometry for the best inside point.private void
InteriorPointArea.addPolygon
(Geometry geometry) Finds an interior point of a Polygon.private void
PointLocator.computeLocation
(Coordinate p, Geometry geom) private void
MinimumDiameter.computeWidthConvex
(Geometry convexGeom) private static Coordinate[]
ConvexHull.extractCoordinates
(Geometry geom) 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 geometrystatic 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 Geometryint
PointLocator.locate
(Coordinate p, Geometry geom) Computes the topological relationship (Location
) of a single point to a Geometry.private Geometry
InteriorPointArea.widestGeometry
(Geometry geometry) Constructors in org.locationtech.jts.algorithm with parameters of type GeometryModifierConstructorDescriptionCreates a new instance for computing the centroid of a geometryConvexHull
(Geometry geometry) Create a new convex hull construction for the inputGeometry
.Creates a new interior point finder for an areal geometry.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 givenGeometry
.MinimumDiameter
(Geometry inputGeom, boolean isConvex) Compute a minimum diameter for a giverGeometry
, with a hint if the Geometry is convex (e.g. -
Uses of Geometry in org.locationtech.jts.algorithm.distance
Fields in org.locationtech.jts.algorithm.distance declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
DiscreteHausdorffDistance.g0
private Geometry
DiscreteHausdorffDistance.g1
private Geometry
DiscreteHausdorffDistance.MaxDensifiedByFractionDistanceFilter.geom
private Geometry
DiscreteHausdorffDistance.MaxPointDistanceFilter.geom
Methods in org.locationtech.jts.algorithm.distance with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
static void
DistanceToPoint.computeDistance
(Geometry geom, Coordinate pt, PointPairDistance ptDist) private void
DiscreteHausdorffDistance.computeOrientedDistance
(Geometry discreteGeom, Geometry geom, PointPairDistance ptDist) static double
static double
Constructors in org.locationtech.jts.algorithm.distance with parameters of type GeometryModifierConstructorDescriptionMaxDensifiedByFractionDistanceFilter
(Geometry geom, double fraction) -
Uses of Geometry in org.locationtech.jts.algorithm.locate
Fields in org.locationtech.jts.algorithm.locate declared as GeometryMethods in org.locationtech.jts.algorithm.locate with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
static int
SimplePointInAreaLocator.locate
(Coordinate p, Geometry geom) private static int
SimplePointInAreaLocator.locateInGeometry
(Coordinate p, Geometry geom) Constructors in org.locationtech.jts.algorithm.locate with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.algorithm.match
Methods in org.locationtech.jts.algorithm.match with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.awt
Methods in org.locationtech.jts.awt that return GeometryModifier and TypeMethodDescriptionstatic 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 aGeometry
using a standard flatness factor.ShapeReader.read
(PathIterator pathIt) Converts a flat path to aGeometry
.static Geometry
ShapeReader.read
(PathIterator pathIt, GeometryFactory geomFact) Converts a flat path to aGeometry
.static Geometry
ShapeReader.read
(Shape shp, double flatness, GeometryFactory geomFact) Converts a Shape to a Geometry, flattening it first.Methods in org.locationtech.jts.awt with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.densify
Fields in org.locationtech.jts.densify declared as GeometryMethods in org.locationtech.jts.densify that return GeometryModifier and TypeMethodDescriptionprivate Geometry
Densifier.DensifyTransformer.createValidArea
(Geometry roughAreaGeom) Creates a valid area geometry from one that possibly has bad topology (i.e.static Geometry
Densifies a geometry using a given distance tolerance, and respecting the input geometry'sPrecisionModel
.Densifier.getResultGeometry()
Gets the densified geometry.protected Geometry
Densifier.DensifyTransformer.transformMultiPolygon
(MultiPolygon geom, Geometry parent) protected Geometry
Densifier.DensifyTransformer.transformPolygon
(Polygon geom, Geometry parent) Methods in org.locationtech.jts.densify with parameters of type GeometryModifier and TypeMethodDescriptionprivate Geometry
Densifier.DensifyTransformer.createValidArea
(Geometry roughAreaGeom) Creates a valid area geometry from one that possibly has bad topology (i.e.static Geometry
Densifies a geometry using a given distance tolerance, and respecting the input geometry'sPrecisionModel
.protected CoordinateSequence
Densifier.DensifyTransformer.transformCoordinates
(CoordinateSequence coords, Geometry parent) protected Geometry
Densifier.DensifyTransformer.transformMultiPolygon
(MultiPolygon geom, Geometry parent) protected Geometry
Densifier.DensifyTransformer.transformPolygon
(Polygon geom, Geometry parent) Constructors in org.locationtech.jts.densify with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.dissolve
Fields in org.locationtech.jts.dissolve declared as GeometryMethods in org.locationtech.jts.dissolve that return GeometryModifier and TypeMethodDescriptionstatic Geometry
Dissolves the linear components in a geometry.LineDissolver.getResult()
Gets the dissolved result as a MultiLineString.Methods in org.locationtech.jts.dissolve with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.edgegraph
Methods in org.locationtech.jts.edgegraph with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.geom
Subclasses of Geometry in org.locationtech.jts.geomModifier and TypeClassDescriptionclass
Models a collection ofGeometry
s of arbitrary type and dimension.class
Models an OGC SFSLinearRing
.class
Models an OGC-styleLineString
.class
Models a collection ofLineString
s.class
Models a collection ofPoint
s.class
Models a collection ofPolygon
s.class
Represents a single point.class
Represents a polygon with linear edges, which may include holes.Fields in org.locationtech.jts.geom declared as GeometryModifier and TypeFieldDescriptionprotected Geometry[]
GeometryCollection.geometries
Internal representation of thisGeometryCollection
.private Geometry
GeometryCollectionIterator.parent
TheGeometry
being iterated over.Methods in org.locationtech.jts.geom that return GeometryModifier and TypeMethodDescriptionGeometry.buffer
(double distance) Computes a buffer area around this geometry having the given width.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.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.GeometryFactory.buildGeometry
(Collection geomList) Build an appropriateGeometry
,MultiGeometry
, orGeometryCollection
to contain theGeometry
s in it.Geometry.convexHull()
Computes the smallest convexPolygon
that contains all the points in theGeometry
.Polygon.convexHull()
abstract Geometry
Geometry.copy()
Creates and returns a full copy of thisGeometry
object (including all coordinates contained by it).GeometryFactory.createGeometry
(Geometry g) Creates a deep copy of the inputGeometry
.Geometry.difference
(Geometry other) Computes aGeometry
representing the closure of the point-set of the points contained in thisGeometry
that are not contained in theother
Geometry.abstract Geometry
Geometry.getBoundary()
Returns the boundary, or an empty geometry of appropriate dimension if thisGeometry
is empty.GeometryCollection.getBoundary()
LineString.getBoundary()
Gets the boundary of this geometry.MultiLineString.getBoundary()
Gets the boundary of this geometry.MultiPoint.getBoundary()
Gets the boundary of this geometry.MultiPolygon.getBoundary()
Computes the boundary of this geometryPoint.getBoundary()
Gets the boundary of this geometry.Polygon.getBoundary()
Computes the boundary of this geometryGeometry.getEnvelope()
Gets a Geometry representing the envelope (bounding box) of thisGeometry
.Geometry.getGeometryN
(int n) Returns an elementGeometry
from aGeometryCollection
(orthis
, if the geometry is not a collection).GeometryCollection.getGeometryN
(int n) Geometry.intersection
(Geometry other) Computes aGeometry
representing the point-set which is common to both thisGeometry
and theother
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 geometryabstract Geometry
Geometry.reverse()
Computes a new geometry which has all component coordinate sequences in reverse order (opposite orientation) to this one.GeometryCollection.reverse()
Creates aGeometryCollection
with every component reversed.LinearRing.reverse()
LineString.reverse()
Creates aLineString
whose coordinates are in the reverse order of this objectsMultiLineString.reverse()
Creates aMultiLineString
in the reverse order to this object.MultiPolygon.reverse()
Creates aMultiPolygon
with every component reversed.Point.reverse()
Polygon.reverse()
Geometry.symDifference
(Geometry other) Computes aGeometry
representing the closure of the point-set which is the union of the points in thisGeometry
which are not contained in theother
Geometry, with the points in theother
Geometry not contained in thisGeometry
.GeometryFactory.toGeometry
(Envelope envelope) Creates aGeometry
with the same extent as the given envelope.OctagonalEnvelope.toGeometry
(GeometryFactory geomFactory) static Geometry[]
GeometryFactory.toGeometryArray
(Collection geometries) Converts theList
to an array.Geometry.union()
Computes the union of all the elements of this geometry.Computes aGeometry
representing the point-set which is contained in both thisGeometry
and theother
Geometry.Methods in org.locationtech.jts.geom with parameters of type GeometryModifier and TypeMethodDescriptionprotected void
Geometry.checkNotGeometryCollection
(Geometry g) Throws an exception ifg
's class isGeometryCollection
.boolean
Tests whether this geometry contains the argument geometry.boolean
Tests whether this geometry is covered by the argument geometry.boolean
Tests whether this geometry covers the argument geometry.GeometryFactory.createGeometry
(Geometry g) Creates a deep copy of the inputGeometry
.GeometryFactory.createGeometryCollection
(Geometry[] geometries) Creates a GeometryCollection using the given Geometries; a null or empty array will create an empty GeometryCollection.private Point
Geometry.createPointFromInternalCoord
(Coordinate coord, Geometry exemplar) static Point
GeometryFactory.createPointFromInternalCoord
(Coordinate coord, Geometry exemplar) boolean
Tests whether this geometry crosses the argument geometry.Geometry.difference
(Geometry other) Computes aGeometry
representing the closure of the point-set of the points contained in thisGeometry
that are not contained in theother
Geometry.boolean
Tests whether this geometry is disjoint from the argument geometry.double
Returns the minimum distance between thisGeometry
and anotherGeometry
.boolean
Tests whether this geometry is topologically equal to the argument geometry.boolean
Geometry.equalsExact
(Geometry other) Returns true if the twoGeometry
s are exactly equal.abstract boolean
Geometry.equalsExact
(Geometry other, double tolerance) Returns true if the twoGeometry
s are exactly equal, up to a specified distance tolerance.boolean
GeometryCollection.equalsExact
(Geometry other, double tolerance) boolean
LineString.equalsExact
(Geometry other, double tolerance) boolean
MultiLineString.equalsExact
(Geometry other, double tolerance) boolean
MultiPoint.equalsExact
(Geometry other, double tolerance) boolean
MultiPolygon.equalsExact
(Geometry other, double tolerance) boolean
Point.equalsExact
(Geometry other, double tolerance) boolean
Polygon.equalsExact
(Geometry other, double tolerance) boolean
Geometry.equalsNorm
(Geometry g) Tests whether two geometries are exactly equal in their normalized forms.boolean
Geometry.equalsTopo
(Geometry g) Tests whether this geometry is topologically equal to the argument geometry as defined by the SFSequals
predicate.void
OctagonalEnvelope.expandToInclude
(Geometry g) void
Performs an operation with or ongeom
.void
Performs an operation with or ongeom
.void
protected static boolean
Geometry.hasNonEmptyElements
(Geometry[] geometries) Returns true if the array contains any non-emptyGeometry
s.Geometry.intersection
(Geometry other) Computes aGeometry
representing the point-set which is common to both thisGeometry
and theother
Geometry.boolean
Geometry.intersects
(Geometry g) Tests whether this geometry intersects the argument geometry.private static boolean
protected boolean
Geometry.isEquivalentClass
(Geometry other) Returns whether the twoGeometry
s are equal, from the point of view of theequalsExact
method.protected boolean
LineString.isEquivalentClass
(Geometry other) boolean
Geometry.isWithinDistance
(Geometry geom, double distance) Tests whether the distance from thisGeometry
to another is less than or equal to a specified value.static Geometry
OctagonalEnvelope.octagonalEnvelope
(Geometry geom) Gets the octagonal envelope of a geometryboolean
Tests whether this geometry overlaps the specified geometry.Returns the DE-9IMIntersectionMatrix
for the twoGeometry
s.boolean
Tests whether the elements in the DE-9IMIntersectionMatrix
for the twoGeometry
s match the elements inintersectionPattern
.Geometry.symDifference
(Geometry other) Computes aGeometry
representing the closure of the point-set which is the union of the points in thisGeometry
which are not contained in theother
Geometry, with the points in theother
Geometry not contained in thisGeometry
.boolean
Tests whether this geometry touches the argument geometry.Computes aGeometry
representing the point-set which is contained in both thisGeometry
and theother
Geometry.boolean
Tests whether this geometry is within the specified geometry.Constructors in org.locationtech.jts.geom with parameters of type GeometryModifierConstructorDescriptionGeometryCollection
(Geometry[] geometries, GeometryFactory factory) GeometryCollection
(Geometry[] geometries, PrecisionModel precisionModel, int SRID) Deprecated.Use GeometryFactory insteadGeometryCollectionIterator
(Geometry parent) Constructs an iterator over the givenGeometry
.OctagonalEnvelope
(Geometry geom) Creates a new null bounding octagon bounding aGeometry
-
Uses of Geometry in org.locationtech.jts.geom.prep
Fields in org.locationtech.jts.geom.prep declared as GeometryMethods in org.locationtech.jts.geom.prep that return GeometryModifier and TypeMethodDescriptionBasicPreparedGeometry.getGeometry()
PreparedGeometry.getGeometry()
Gets the originalGeometry
which has been prepared.Methods in org.locationtech.jts.geom.prep with parameters of type GeometryModifier and TypeMethodDescriptionboolean
Default implementation.boolean
Tests whether the baseGeometry
contains a given geometry.boolean
boolean
Tests whether this PreparedPolygon contains a given geometry.static boolean
PreparedPolygonContains.contains
(PreparedPolygon prep, Geometry geom) Computes the contains predicate between aPreparedPolygon
and aGeometry
.boolean
BasicPreparedGeometry.containsProperly
(Geometry g) Default implementation.boolean
PreparedGeometry.containsProperly
(Geometry geom) Tests whether the baseGeometry
properly contains a given geometry.boolean
PreparedPolygon.containsProperly
(Geometry g) boolean
PreparedPolygonContainsProperly.containsProperly
(Geometry geom) Tests whether this PreparedPolygon containsProperly a given geometry.static boolean
PreparedPolygonContainsProperly.containsProperly
(PreparedPolygon prep, Geometry geom) Computes the containsProperly predicate between aPreparedPolygon
and aGeometry
.boolean
Default implementation.boolean
Tests whether the baseGeometry
is covered by a given geometry.boolean
Default implementation.boolean
Tests whether the baseGeometry
covers a given geometry.boolean
boolean
Tests whether this PreparedPolygon covers a given geometry.static boolean
PreparedPolygonCovers.covers
(PreparedPolygon prep, Geometry geom) Computes the covers predicate between aPreparedPolygon
and aGeometry
.Creates a newPreparedGeometry
appropriate for the argumentGeometry
.boolean
Default implementation.boolean
Tests whether the baseGeometry
crosses a given geometry.boolean
Standard implementation for all geometries.boolean
Tests whether the baseGeometry
is disjoint from a given geometry.protected boolean
BasicPreparedGeometry.envelopeCovers
(Geometry g) Determines whether the envelope of this geometry covers the Geometry g.protected boolean
BasicPreparedGeometry.envelopesIntersect
(Geometry g) Determines whether a Geometry g interacts with this geometry by testing the geometry envelopes.protected boolean
Evaluate the contains or covers relationship for the given geometry.private void
AbstractPreparedPolygonContains.findAndClassifyIntersections
(Geometry geom) protected abstract boolean
AbstractPreparedPolygonContains.fullTopologicalPredicate
(Geometry geom) Computes the full topological predicate.protected boolean
PreparedPolygonContains.fullTopologicalPredicate
(Geometry geom) Computes the full topological contains predicate.protected boolean
PreparedPolygonCovers.fullTopologicalPredicate
(Geometry geom) Computes the full topological covers predicate.boolean
BasicPreparedGeometry.intersects
(Geometry g) Default implementation.boolean
PreparedGeometry.intersects
(Geometry geom) Tests whether the baseGeometry
intersects a given geometry.boolean
PreparedLineString.intersects
(Geometry g) boolean
PreparedLineStringIntersects.intersects
(Geometry geom) Tests whether this geometry intersects a given geometry.static boolean
PreparedLineStringIntersects.intersects
(PreparedLineString prep, Geometry geom) Computes the intersects predicate between aPreparedLineString
and aGeometry
.boolean
PreparedPoint.intersects
(Geometry g) Tests whether this point intersects aGeometry
.boolean
PreparedPolygon.intersects
(Geometry g) boolean
PreparedPolygonIntersects.intersects
(Geometry geom) Tests whether this PreparedPolygon intersects a given geometry.static boolean
PreparedPolygonIntersects.intersects
(PreparedPolygon prep, Geometry geom) Computes the intersects predicate between aPreparedPolygon
and aGeometry
.protected boolean
PreparedPolygonPredicate.isAllTestComponentsInTarget
(Geometry testGeom) Tests whether all components of the test Geometry are contained in the target geometry.protected boolean
PreparedPolygonPredicate.isAllTestComponentsInTargetInterior
(Geometry testGeom) Tests whether all components of the test Geometry are contained in the interior of the target geometry.protected boolean
PreparedPolygonPredicate.isAnyTargetComponentInAreaTest
(Geometry testGeom, List targetRepPts) Tests whether any component of the target geometry intersects the test geometry (which must be an areal geometry)boolean
BasicPreparedGeometry.isAnyTargetComponentInTest
(Geometry testGeom) Tests whether any representative of the target geometry intersects the test geometry.protected boolean
PreparedPolygonPredicate.isAnyTestComponentInTarget
(Geometry testGeom) Tests whether any component of the test Geometry intersects the area of the target geometry.protected boolean
PreparedPolygonPredicate.isAnyTestComponentInTargetInterior
(Geometry testGeom) Tests whether any component of the test Geometry intersects the interior of the target geometry.protected boolean
PreparedLineStringIntersects.isAnyTestPointInTarget
(Geometry testGeom) Tests whether any representative point of the test Geometry intersects the target geometry.private boolean
AbstractPreparedPolygonContains.isProperIntersectionImpliesNotContainedSituation
(Geometry testGeom) private boolean
AbstractPreparedPolygonContains.isSingleShell
(Geometry geom) Tests whether a geometry consists of a single polygon with no holes.boolean
Default implementation.boolean
Tests whether the baseGeometry
overlaps a given geometry.static PreparedGeometry
Creates a newPreparedGeometry
appropriate for the argumentGeometry
.boolean
Default implementation.boolean
Tests whether the baseGeometry
touches a given geometry.boolean
Default implementation.boolean
Tests whether the baseGeometry
is within a given geometry.Constructors in org.locationtech.jts.geom.prep with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.geom.util
Fields in org.locationtech.jts.geom.util declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
GeometryTransformer.inputGeom
Possible extensions: getParent() method to return immediate parent e.g.Methods in org.locationtech.jts.geom.util that return GeometryModifier and TypeMethodDescriptionGeometryCombiner.combine()
Computes the combination of the input geometries to produce the most appropriateGeometry
orGeometryCollection
static Geometry
GeometryCombiner.combine
(Collection geoms) Combines a collection of geometries.static Geometry
Combines two geometries.static Geometry
Combines three geometries.SineStarFactory.createSineStar()
Generates the geometry for the sine starfinal Geometry
GeometryEditor.CoordinateOperation.edit
(Geometry geometry, GeometryFactory factory) final Geometry
GeometryEditor.CoordinateSequenceOperation.edit
(Geometry geometry, GeometryFactory factory) GeometryEditor.edit
(Geometry geometry, GeometryEditor.GeometryEditorOperation operation) Edit the inputGeometry
with the given edit operation.GeometryEditor.GeometryEditorOperation.edit
(Geometry geometry, GeometryFactory factory) Edits a Geometry by returning a new Geometry with a modification.GeometryEditor.NoOpGeometryOperation.edit
(Geometry geometry, GeometryFactory factory) private Geometry
GeometryEditor.editInternal
(Geometry geometry, GeometryEditor.GeometryEditorOperation operation) static Geometry
LinearComponentExtracter.getGeometry
(Geometry geom) Extracts the linear components from a singleGeometry
and returns them as either aLineString
orMultiLineString
.static Geometry
LinearComponentExtracter.getGeometry
(Geometry geom, boolean forceToLineString) Extracts the linear components from a singleGeometry
and returns them as either aLineString
orMultiLineString
.static Geometry
LineStringExtracter.getGeometry
(Geometry geom) Extracts theLineString
elements from a singleGeometry
and returns them as either aLineString
orMultiLineString
.GeometryTransformer.getInputGeometry()
Utility function to make input geometry availablestatic Geometry
GeometryMapper.map
(Geometry geom, GeometryMapper.MapOp op) Maps the members of aGeometry
(which may be atomic or composite) into another Geometry of most specific type.Computes a new geometry value.Creates a newGeometry
which is the result of this transformation applied to the input Geometry.final 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 aLineString
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) Methods in org.locationtech.jts.geom.util with parameters of type GeometryModifier and TypeMethodDescriptionvoid
static Geometry
Combines two geometries.static Geometry
Combines three geometries.abstract Coordinate[]
GeometryEditor.CoordinateOperation.edit
(Coordinate[] coordinates, Geometry geometry) Edits the array ofCoordinate
s from aGeometry
.final Geometry
GeometryEditor.CoordinateOperation.edit
(Geometry geometry, GeometryFactory factory) abstract CoordinateSequence
GeometryEditor.CoordinateSequenceOperation.edit
(CoordinateSequence coordSeq, Geometry geometry) Edits aCoordinateSequence
from aGeometry
.final Geometry
GeometryEditor.CoordinateSequenceOperation.edit
(Geometry geometry, GeometryFactory factory) GeometryEditor.edit
(Geometry geometry, GeometryEditor.GeometryEditorOperation operation) Edit the inputGeometry
with the given edit operation.GeometryEditor.GeometryEditorOperation.edit
(Geometry geometry, GeometryFactory factory) Edits a Geometry by returning a new Geometry with a modification.GeometryEditor.NoOpGeometryOperation.edit
(Geometry geometry, GeometryFactory factory) private Geometry
GeometryEditor.editInternal
(Geometry geometry, GeometryEditor.GeometryEditorOperation operation) static List
static List
private void
GeometryCombiner.extractElements
(Geometry geom, List elems) void
void
void
void
void
void
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 singleGeometry
and returns them as either aLineString
orMultiLineString
.static Geometry
LinearComponentExtracter.getGeometry
(Geometry geom, boolean forceToLineString) Extracts the linear components from a singleGeometry
and returns them as either aLineString
orMultiLineString
.static Geometry
LineStringExtracter.getGeometry
(Geometry geom) Extracts theLineString
elements from a singleGeometry
and returns them as either aLineString
orMultiLineString
.static List
Extracts the linear components from a single geometry.static List
Extracts the linear components from a single geometry.static Collection
LinearComponentExtracter.getLines
(Geometry geom, Collection lines) Extracts the linear components from a singleGeometry
and adds them to the providedCollection
.static Collection
LinearComponentExtracter.getLines
(Geometry geom, Collection lines, boolean forceToLineString) Extracts the linear components from a singleGeometry
and adds them to the providedCollection
.static List
static List
static List
static List
static List
PolygonExtracter.getPolygons
(Geometry geom) static List
PolygonExtracter.getPolygons
(Geometry geom, List list) static Geometry
GeometryMapper.map
(Geometry geom, GeometryMapper.MapOp op) Maps the members of aGeometry
(which may be atomic or composite) into another Geometry of most specific type.Computes a new geometry value.Creates a newGeometry
which is the result of this transformation applied to the input Geometry.final Geometry
protected CoordinateSequence
GeometryTransformer.transformCoordinates
(CoordinateSequence coords, Geometry parent) Transforms aCoordinateSequence
.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 aLineString
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
-
Uses of Geometry in org.locationtech.jts.geomgraph
Fields in org.locationtech.jts.geomgraph declared as GeometryMethods in org.locationtech.jts.geomgraph that return GeometryMethods in org.locationtech.jts.geomgraph with parameters of type GeometryConstructors in org.locationtech.jts.geomgraph with parameters of type GeometryModifierConstructorDescriptionGeometryGraph
(int argIndex, Geometry parentGeom) GeometryGraph
(int argIndex, Geometry parentGeom, BoundaryNodeRule boundaryNodeRule) -
Uses of Geometry in org.locationtech.jts.io
Methods in org.locationtech.jts.io that return GeometryModifier and TypeMethodDescriptionWKBReader.read
(byte[] bytes) Reads a singleGeometry
in WKB format from a byte array.private Geometry
WKBReader.readGeometry()
private Geometry
WKTReader.readGeometryTaggedText()
Creates aGeometry
using the next token in the stream.private Geometry
Sets the SRID, if it was specified in the WKBMethods in org.locationtech.jts.io with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
WKTWriter.appendGeometryTaggedText
(Geometry geometry, int level, Writer writer) Converts aGeometry
to <Geometry Tagged Text> format, then appends it to the writer.private Geometry
Sets the SRID, if it was specified in the WKBbyte[]
Writes aGeometry
into a byte array.void
Converts aGeometry
to its Well-known Text representation.void
Converts aGeometry
to its Well-known Text representation.WKTWriter.writeFormatted
(Geometry geometry) Same aswrite
, but with newlines and spaces to make the well-known text more readable.private void
WKTWriter.writeFormatted
(Geometry geometry, boolean useFormatting, Writer writer) Converts aGeometry
to its Well-known Text representation.void
WKTWriter.writeFormatted
(Geometry geometry, Writer writer) Same aswrite
, but with newlines and spaces to make the well-known text more readable.private void
WKBWriter.writeGeometryType
(int geometryType, Geometry g, OutStream os) -
Uses of Geometry in org.locationtech.jts.io.geojson
Methods in org.locationtech.jts.io.geojson that return GeometryModifier and TypeMethodDescriptionprivate Geometry
GeoJsonReader.create
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) private Geometry
GeoJsonReader.createGeometryCollection
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) private Geometry
GeoJsonReader.createLineString
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) private Geometry
GeoJsonReader.createMultiLineString
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) private Geometry
GeoJsonReader.createMultiPoint
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) private Geometry
GeoJsonReader.createMultiPolygon
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) private Geometry
GeoJsonReader.createPoint
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) private Geometry
GeoJsonReader.createPolygon
(Map<String, Object> geometryMap, GeometryFactory geometryFactory) Reads a GeoJson Geometry from a String into a singleGeometry
.Methods in org.locationtech.jts.io.geojson with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.io.gml2
Methods in org.locationtech.jts.io.gml2 that return GeometryModifier and TypeMethodDescriptionGMLHandler.getGeometry()
Gets the geometry parsed by this handler.GMLReader.read
(Reader reader, GeometryFactory geometryFactory) Reads a GML2 Geometry from aReader
into a singleGeometry
If a collection of Geometries is found, aGeometryCollection
is returned.GMLReader.read
(String gml, GeometryFactory geometryFactory) Reads a GML2 Geometry from a String into a singleGeometry
If a collection of geometries is found, aGeometryCollection
is returned.Methods in org.locationtech.jts.io.gml2 with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
GMLWriter.startGeomTag
(String geometryName, Geometry g, Writer writer) Writes aGeometry
in GML2 format to a String.void
private void
private void
GMLWriter.writeAttributes
(Geometry geom, Writer writer) private void
GMLWriter.writeCustomElements
(Geometry geom, Writer writer) -
Uses of Geometry in org.locationtech.jts.io.kml
Methods in org.locationtech.jts.io.kml with parameters of type GeometryModifier and TypeMethodDescriptionWrites aGeometry
in KML format as a string.void
void
KMLWriter.write
(Geometry geometry, StringBuffer buf) Appends the KML representation of aGeometry
to aStringBuffer
.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.private void
KMLWriter.writeGeometry
(Geometry g, int level, StringBuffer buf) -
Uses of Geometry in org.locationtech.jts.linearref
Fields in org.locationtech.jts.linearref declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
ExtractLineByLocation.line
private Geometry
LengthIndexedLine.linearGeom
private Geometry
LengthIndexOfPoint.linearGeom
private Geometry
LengthLocationMap.linearGeom
private Geometry
LinearIterator.linearGeom
private Geometry
LocationIndexedLine.linearGeom
private Geometry
LocationIndexOfLine.linearGeom
private Geometry
LocationIndexOfPoint.linearGeom
Methods in org.locationtech.jts.linearref that return GeometryModifier and TypeMethodDescriptionprivate Geometry
ExtractLineByLocation.computeLinear
(LinearLocation start, LinearLocation end) Assumes input is valid (e.g.static Geometry
ExtractLineByLocation.extract
(Geometry line, LinearLocation start, LinearLocation end) Computes the subline of aLineString
between twoLinearLocation
s on the line.ExtractLineByLocation.extract
(LinearLocation start, LinearLocation end) Extracts a subline of the input.LengthIndexedLine.extractLine
(double startIndex, double endIndex) Computes theLineString
for the interval on the line between the given indices.LocationIndexedLine.extractLine
(LinearLocation startIndex, LinearLocation endIndex) Computes theLineString
for the interval on the line between the given indices.LinearGeometryBuilder.getGeometry()
private Geometry
Methods in org.locationtech.jts.linearref with parameters of type GeometryModifier and TypeMethodDescriptionvoid
Ensures the indexes are valid for a given linearGeometry
.static Geometry
ExtractLineByLocation.extract
(Geometry line, LinearLocation start, LinearLocation end) Computes the subline of aLineString
between twoLinearLocation
s on the line.LinearLocation.getCoordinate
(Geometry linearGeom) Gets theCoordinate
along the given linearGeometry
which is referenced by this location.static LinearLocation
LinearLocation.getEndLocation
(Geometry linear) Gets a location which refers to the end of a linearGeometry
.static double
LengthLocationMap.getLength
(Geometry linearGeom, LinearLocation loc) Computes the length for a givenLinearLocation
on a linearGeometry
.static LinearLocation
LengthLocationMap.getLocation
(Geometry linearGeom, double length) Computes theLinearLocation
for a given length along a linearGeometry
.static LinearLocation
LengthLocationMap.getLocation
(Geometry linearGeom, double length, boolean resolveLower) Computes theLinearLocation
for a given length along a linearGeometry
, with control over how the location is resolved at component endpoints.LinearLocation.getSegment
(Geometry linearGeom) Gets aLineSegment
representing the segment of the given linearGeometry
which contains this location.double
LinearLocation.getSegmentLength
(Geometry linearGeom) Gets the length of the segment in the given Geometry containing this location.static double
LengthIndexOfPoint.indexOf
(Geometry linearGeom, Coordinate inputPt) static LinearLocation
LocationIndexOfPoint.indexOf
(Geometry linearGeom, Coordinate inputPt) static double
LengthIndexOfPoint.indexOfAfter
(Geometry linearGeom, Coordinate inputPt, double minIndex) static LinearLocation
LocationIndexOfPoint.indexOfAfter
(Geometry linearGeom, Coordinate inputPt, LinearLocation minIndex) double[]
Computes the indices for a subline of the line.Computes the indices for a subline of the line.static LinearLocation[]
MD - this algorithm has been extracted into a class because it is intended to validate that the subline truly is a subline, and also to use the internal vertex information to unambiguously locate the subline.boolean
LinearLocation.isEndpoint
(Geometry linearGeom) Tests whether this location is an endpoint of the linear component it refers to.boolean
Tests whether this location refers to a valid location on the given linearGeometry
.private Geometry
void
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 linearGeometry
, if the vertex is closer than minDistance.Converts a linear location to the lowest equivalent location index.Constructors in org.locationtech.jts.linearref with parameters of type GeometryModifierConstructorDescriptionLengthIndexedLine
(Geometry linearGeom) Constructs an object which allows a linearGeometry
to be linearly referenced using length as an index.LengthIndexOfPoint
(Geometry linearGeom) LengthLocationMap
(Geometry linearGeom) LinearIterator
(Geometry linear) Creates an iterator initialized to the start of a linearGeometry
LinearIterator
(Geometry linearGeom, int componentIndex, int vertexIndex) Creates an iterator starting at a specified component and vertex in a linearGeometry
LinearIterator
(Geometry linear, LinearLocation start) Creates an iterator starting at aLinearLocation
on a linearGeometry
LocationIndexedLine
(Geometry linearGeom) Constructs an object which allows linear referencing along a given linearGeometry
.LocationIndexOfLine
(Geometry linearGeom) LocationIndexOfPoint
(Geometry linearGeom) -
Uses of Geometry in org.locationtech.jts.noding
Methods in org.locationtech.jts.noding that return GeometryModifier and TypeMethodDescriptionstatic Geometry
SegmentStringUtil.toGeometry
(Collection segStrings, GeometryFactory geomFact) Converts a collection ofSegmentString
s into aGeometry
.Methods in org.locationtech.jts.noding with parameters of type GeometryModifier and TypeMethodDescriptionstatic List
SegmentStringUtil.extractNodedSegmentStrings
(Geometry geom) Extracts all linear components from a givenGeometry
toSegmentString
s.static List
SegmentStringUtil.extractSegmentStrings
(Geometry geom) Extracts all linear components from a givenGeometry
toSegmentString
s. -
Uses of Geometry in org.locationtech.jts.operation
Fields in org.locationtech.jts.operation declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
BoundaryOp.geom
private Geometry
IsSimpleOp.inputGeom
Methods in org.locationtech.jts.operation that return GeometryModifier and TypeMethodDescriptionprivate Geometry
BoundaryOp.boundaryLineString
(LineString line) private Geometry
BoundaryOp.boundaryMultiLineString
(MultiLineString mLine) GeometryGraphOperation.getArgGeometry
(int i) BoundaryOp.getBoundary()
static Geometry
BoundaryOp.getBoundary
(Geometry g) static Geometry
BoundaryOp.getBoundary
(Geometry g, BoundaryNodeRule bnRule) Methods in org.locationtech.jts.operation with parameters of type GeometryModifier and TypeMethodDescriptionprivate boolean
IsSimpleOp.computeSimple
(Geometry geom) static Geometry
BoundaryOp.getBoundary
(Geometry g) static Geometry
BoundaryOp.getBoundary
(Geometry g, BoundaryNodeRule bnRule) private boolean
IsSimpleOp.isSimpleGeometryCollection
(Geometry geom) Semantics for GeometryCollection is simple iff all components are simple.private boolean
IsSimpleOp.isSimpleLinearGeometry
(Geometry geom) private boolean
IsSimpleOp.isSimplePolygonal
(Geometry geom) Computes simplicity for polygonal geometries.Constructors in org.locationtech.jts.operation with parameters of type GeometryModifierConstructorDescriptionBoundaryOp
(Geometry geom) BoundaryOp
(Geometry geom, BoundaryNodeRule bnRule) 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 RuleIsSimpleOp
(Geometry geom, BoundaryNodeRule boundaryNodeRule) Creates a simplicity checker using a givenBoundaryNodeRule
-
Uses of Geometry in org.locationtech.jts.operation.buffer
Fields in org.locationtech.jts.operation.buffer declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
BufferOp.argGeom
private Geometry
OffsetCurveSetBuilder.inputGeom
private Geometry
BufferOp.resultGeometry
Methods in org.locationtech.jts.operation.buffer that return GeometryModifier and TypeMethodDescriptionstatic Geometry
Computes the buffer of a geometry for a given buffer distance.static Geometry
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
BufferOp.bufferOp
(Geometry g, double distance, BufferParameters params) Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.private static Geometry
BufferBuilder.convertSegStrings
(Iterator it) private Geometry
BufferBuilder.createEmptyResultGeometry()
Gets the standard result for an empty buffer.BufferOp.getResultGeometry
(double distance) Returns the buffer computed for a geometry for a given buffer distance.Methods in org.locationtech.jts.operation.buffer with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
static Geometry
Computes the buffer of a geometry for a given buffer distance.static Geometry
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
BufferOp.bufferOp
(Geometry g, double distance, BufferParameters params) Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.private static double
BufferOp.precisionScaleFactor
(Geometry g, double distance, int maxPrecisionDigits) Compute a scale factor to limit the precision of a given combination of Geometry and buffer distance.Constructors in org.locationtech.jts.operation.buffer with parameters of type GeometryModifierConstructorDescriptionInitializes a buffer computation for the given geometryBufferOp
(Geometry g, BufferParameters bufParams) Initializes a buffer computation for the given geometry with the given set of parametersOffsetCurveSetBuilder
(Geometry inputGeom, double distance, OffsetCurveBuilder curveBuilder) -
Uses of Geometry in org.locationtech.jts.operation.buffer.validate
Fields in org.locationtech.jts.operation.buffer.validate declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
BufferDistanceValidator.errorIndicator
private Geometry
BufferResultValidator.errorIndicator
private Geometry
BufferCurveMaximumDistanceFinder.MaxMidpointDistanceFilter.geom
private Geometry
BufferCurveMaximumDistanceFinder.MaxPointDistanceFilter.geom
private Geometry
BufferDistanceValidator.input
private Geometry
BufferResultValidator.input
private Geometry
BufferCurveMaximumDistanceFinder.inputGeom
private Geometry
BufferDistanceValidator.result
private Geometry
BufferResultValidator.result
Methods in org.locationtech.jts.operation.buffer.validate that return GeometryModifier and TypeMethodDescriptionBufferDistanceValidator.getErrorIndicator()
Gets a geometry which indicates the location and nature of a validation failure.BufferResultValidator.getErrorIndicator()
Gets a geometry which indicates the location and nature of a validation failure.private Geometry
BufferDistanceValidator.getPolygonLines
(Geometry g) Methods in org.locationtech.jts.operation.buffer.validate with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
BufferDistanceValidator.checkMaximumDistance
(Geometry input, Geometry bufCurve, double maxDist) Checks that the furthest distance from the buffer curve to the input is less than the given maximum distance.private void
BufferDistanceValidator.checkMinimumDistance
(Geometry g1, Geometry g2, double minDist) Checks that two geometries are at least a minimum distance apart.static void
DistanceToPointFinder.computeDistance
(Geometry geom, Coordinate pt, PointPairDistance ptDist) private void
BufferCurveMaximumDistanceFinder.computeMaxMidpointDistance
(Geometry curve) private void
BufferCurveMaximumDistanceFinder.computeMaxVertexDistance
(Geometry curve) double
BufferCurveMaximumDistanceFinder.findDistance
(Geometry bufferCurve) private Geometry
BufferDistanceValidator.getPolygonLines
(Geometry g) static boolean
static String
BufferResultValidator.isValidMsg
(Geometry g, double distance, Geometry result) Checks whether the geometry buffer is valid, and returns an error message if not.Constructors in org.locationtech.jts.operation.buffer.validate with parameters of type GeometryModifierConstructorDescriptionBufferCurveMaximumDistanceFinder
(Geometry inputGeom) BufferDistanceValidator
(Geometry input, double bufDistance, Geometry result) BufferResultValidator
(Geometry input, double distance, Geometry result) -
Uses of Geometry in org.locationtech.jts.operation.distance
Fields in org.locationtech.jts.operation.distance declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
GeometryLocation.component
private Geometry[]
DistanceOp.geom
Methods in org.locationtech.jts.operation.distance that return GeometryModifier and TypeMethodDescriptionGeometryLocation.getGeometryComponent()
Returns the geometry component on (or in) which this location occurs.Methods in org.locationtech.jts.operation.distance with parameters of type GeometryModifier and TypeMethodDescriptionstatic STRtree
static Coordinate[]
DistanceOp.closestPoints
(Geometry g0, Geometry g1) Deprecated.renamed to nearestPointsprivate static List
FacetSequenceTreeBuilder.computeFacetSequences
(Geometry g) Creates facet sequencesstatic double
Compute the distance between the nearest points of two geometries.static double
Computes the distance between two geometries using the indexed approach.void
void
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.Constructors in org.locationtech.jts.operation.distance with parameters of type GeometryModifierConstructorDescriptionDistanceOp
(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, int segIndex, Coordinate pt) Constructs a GeometryLocation specifying a point on a geometry, as well as the segment that the point is on (orGeometryLocation.INSIDE_AREA
if the point is not on a segment).GeometryLocation
(Geometry component, Coordinate pt) Constructs a GeometryLocation specifying a point inside an area geometry.Creates a new distance-finding instance for a given targetGeometry
. -
Uses of Geometry in org.locationtech.jts.operation.distance3d
Fields in org.locationtech.jts.operation.distance3d declared as GeometryMethods in org.locationtech.jts.operation.distance3d with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
Distance3DOp.computeMinDistance
(Geometry g0, Geometry g1, boolean flip) private void
Distance3DOp.computeMinDistanceMultiMulti
(Geometry g0, Geometry g1, boolean flip) private void
Distance3DOp.computeMinDistanceOneMulti
(Geometry g0, Geometry g1, boolean flip) private void
Distance3DOp.computeMinDistanceOneMulti
(PlanarPolygon3D poly, Geometry geom, boolean flip) static double
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.private static PlanarPolygon3D
Convenience method to create a Plane3DPolygonConstructors in org.locationtech.jts.operation.distance3d with parameters of type GeometryModifierConstructorDescriptionDistance3DOp
(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. -
Uses of Geometry in org.locationtech.jts.operation.linemerge
Fields in org.locationtech.jts.operation.linemerge declared as GeometryMethods in org.locationtech.jts.operation.linemerge that return GeometryModifier and TypeMethodDescriptionprivate Geometry
LineSequencer.buildSequencedGeometry
(List sequences) Builds a geometry (LineString
orMultiLineString
) representing the sequence.LineSequencer.getSequencedLineStrings()
Returns theLineString
orMultiLineString
built by the sequencing process, if one exists.static Geometry
Methods in org.locationtech.jts.operation.linemerge with parameters of type GeometryModifier and TypeMethodDescriptionvoid
Adds a Geometry to be processed.void
Adds aGeometry
to be sequenced.static boolean
LineSequencer.isSequenced
(Geometry geom) Tests whether aGeometry
is sequenced correctly.static Geometry
-
Uses of Geometry in org.locationtech.jts.operation.overlay
Fields in org.locationtech.jts.operation.overlay declared as GeometryMethods in org.locationtech.jts.operation.overlay that return GeometryModifier and TypeMethodDescriptionprivate Geometry
OverlayOp.computeGeometry
(List resultPointList, List resultLineList, List resultPolyList, int opcode) 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.OverlayOp.getResultGeometry
(int overlayOpCode) Gets the result of the overlay for a given overlay operation.static Geometry
Computes an overlay operation for the given geometry arguments.Methods in org.locationtech.jts.operation.overlay with parameters of type GeometryModifier and TypeMethodDescriptionstatic 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
Computes an overlay operation for the given geometry arguments.private static int
OverlayOp.resultDimension
(int opCode, Geometry g0, Geometry g1) Constructors in org.locationtech.jts.operation.overlay with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.operation.overlay.snap
Fields in org.locationtech.jts.operation.overlay.snap declared as GeometryModifier and TypeFieldDescriptionprivate Geometry[]
SnapIfNeededOverlayOp.geom
private Geometry[]
SnapOverlayOp.geom
private Geometry
GeometrySnapper.srcGeom
Methods in org.locationtech.jts.operation.overlay.snap that return GeometryModifier and TypeMethodDescriptionstatic Geometry
SnapIfNeededOverlayOp.difference
(Geometry g0, Geometry g1) static Geometry
SnapOverlayOp.difference
(Geometry g0, Geometry g1) SnapIfNeededOverlayOp.getResultGeometry
(int opCode) SnapOverlayOp.getResultGeometry
(int opCode) static Geometry
SnapIfNeededOverlayOp.intersection
(Geometry g0, Geometry g1) static Geometry
SnapOverlayOp.intersection
(Geometry g0, Geometry g1) static Geometry
static Geometry
private Geometry
SnapOverlayOp.prepareResult
(Geometry geom) private Geometry[]
SnapOverlayOp.removeCommonBits
(Geometry[] geom) private Geometry
static Geometry[]
Snaps two geometries together with a given tolerance.private Geometry[]
Snaps the vertices in the componentLineString
s of the source geometry to the vertices of the given snap geometry.GeometrySnapper.snapToSelf
(double snapTolerance, boolean cleanResult) Snaps the vertices in the componentLineString
s of the source geometry to the vertices of the same geometry.static Geometry
GeometrySnapper.snapToSelf
(Geometry geom, double snapTolerance, boolean cleanResult) Snaps a geometry to itself.static Geometry
SnapIfNeededOverlayOp.symDifference
(Geometry g0, Geometry g1) static Geometry
SnapOverlayOp.symDifference
(Geometry g0, Geometry g1) static Geometry
static Geometry
Methods in org.locationtech.jts.operation.overlay.snap with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
SnapOverlayOp.checkValid
(Geometry g) static double
GeometrySnapper.computeOverlaySnapTolerance
(Geometry g) Estimates the snap tolerance for a Geometry, taking into account its precision model.static double
GeometrySnapper.computeOverlaySnapTolerance
(Geometry g0, Geometry g1) static double
GeometrySnapper.computeSizeBasedSnapTolerance
(Geometry g) static Geometry
SnapIfNeededOverlayOp.difference
(Geometry g0, Geometry g1) static Geometry
SnapOverlayOp.difference
(Geometry g0, Geometry g1) private Coordinate[]
GeometrySnapper.extractTargetCoordinates
(Geometry g) static Geometry
SnapIfNeededOverlayOp.intersection
(Geometry g0, Geometry g1) static Geometry
SnapOverlayOp.intersection
(Geometry g0, Geometry g1) static Geometry
static Geometry
private Geometry
SnapOverlayOp.prepareResult
(Geometry geom) private Geometry[]
SnapOverlayOp.removeCommonBits
(Geometry[] geom) private Geometry
static Geometry[]
Snaps two geometries together with a given tolerance.private Geometry[]
Snaps the vertices in the componentLineString
s of the source geometry to the vertices of the given snap geometry.static Geometry
GeometrySnapper.snapToSelf
(Geometry geom, double snapTolerance, boolean cleanResult) Snaps a geometry to itself.static Geometry
SnapIfNeededOverlayOp.symDifference
(Geometry g0, Geometry g1) static Geometry
SnapOverlayOp.symDifference
(Geometry g0, Geometry g1) protected CoordinateSequence
SnapTransformer.transformCoordinates
(CoordinateSequence coords, Geometry parent) static Geometry
static Geometry
Constructors in org.locationtech.jts.operation.overlay.snap with parameters of type GeometryModifierConstructorDescriptionGeometrySnapper
(Geometry srcGeom) Creates a new snapper acting on the given geometrySnapIfNeededOverlayOp
(Geometry g1, Geometry g2) SnapOverlayOp
(Geometry g1, Geometry g2) -
Uses of Geometry in org.locationtech.jts.operation.overlay.validate
Fields in org.locationtech.jts.operation.overlay.validate declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
FuzzyPointLocator.g
private Geometry
OffsetPointGenerator.g
private Geometry[]
OverlayResultValidator.geom
Methods in org.locationtech.jts.operation.overlay.validate with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
OverlayResultValidator.addTestPts
(Geometry g) private static double
OverlayResultValidator.computeBoundaryDistanceTolerance
(Geometry g0, Geometry g1) private MultiLineString
FuzzyPointLocator.extractLinework
(Geometry g) Extracts linework for polygonal components.void
Filters out all linework for polygonal elementsstatic boolean
Constructors in org.locationtech.jts.operation.overlay.validate with parameters of type GeometryModifierConstructorDescriptionFuzzyPointLocator
(Geometry g, double boundaryDistanceTolerance) OverlayResultValidator
(Geometry a, Geometry b, Geometry result) -
Uses of Geometry in org.locationtech.jts.operation.polygonize
Methods in org.locationtech.jts.operation.polygonize that return GeometryModifier and TypeMethodDescriptionPolygonizer.getGeometry()
Gets a geometry representing the polygons formed by the polygonization.Methods in org.locationtech.jts.operation.polygonize with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.operation.predicate
Methods in org.locationtech.jts.operation.predicate with parameters of type GeometryModifier and TypeMethodDescriptionboolean
static boolean
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.private boolean
RectangleContains.isContainedInBoundary
(Geometry geom) protected void
protected void
protected void
-
Uses of Geometry in org.locationtech.jts.operation.relate
Methods in org.locationtech.jts.operation.relate with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
RelateComputer.labelIsolatedEdge
(Edge e, int targetIndex, Geometry target) Label an isolated edge of a graph with its relationship to the target geometry.static IntersectionMatrix
Computes theIntersectionMatrix
for the spatial relationship between twoGeometry
s, using the default (OGC SFS) Boundary Node Rulestatic IntersectionMatrix
RelateOp.relate
(Geometry a, Geometry b, BoundaryNodeRule boundaryNodeRule) Computes theIntersectionMatrix
for the spatial relationship between twoGeometry
s using a specified Boundary Node Rule.Constructors in org.locationtech.jts.operation.relate with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.operation.union
Fields in org.locationtech.jts.operation.union declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
UnionInteracting.g0
private Geometry
UnionInteracting.g1
private Geometry
PointGeometryUnion.otherGeom
private Geometry
PointGeometryUnion.pointGeom
Methods in org.locationtech.jts.operation.union that return GeometryModifier and TypeMethodDescriptionprivate Geometry
CascadedPolygonUnion.binaryUnion
(List geoms) Unions a list of geometries by treating the list as a flattened binary tree, and performing a cascaded union on the tree.private Geometry
CascadedPolygonUnion.binaryUnion
(List geoms, int start, int end) Unions a section of a list using a recursive binary union on each half of the section.private Geometry
CascadedPolygonUnion.bufferUnion
(List geoms) private Geometry
CascadedPolygonUnion.bufferUnion
(Geometry g0, Geometry g1) private Geometry
UnionInteracting.bufferUnion
(Geometry g0, Geometry g1) private Geometry
CascadedPolygonUnion.extractByEnvelope
(Envelope env, Geometry geom, List disjointGeoms) private Geometry
UnionInteracting.extractElements
(Geometry geom, boolean[] interacts, boolean isInteracting) private static Geometry
CascadedPolygonUnion.getGeometry
(List list, int index) Gets the element at a given list index, or null if the index is out of range.private Geometry
CascadedPolygonUnion.repeatedUnion
(List geoms) private static Geometry
CascadedPolygonUnion.restrictToPolygons
(Geometry g) CascadedPolygonUnion.union()
Computes the union of the input geometries.static Geometry
CascadedPolygonUnion.union
(Collection polys) PointGeometryUnion.union()
static Geometry
UnaryUnionOp.union()
Gets the union of the input geometries.static Geometry
UnaryUnionOp.union
(Collection geoms) Computes the geometric union of aCollection
ofGeometry
s.static Geometry
UnaryUnionOp.union
(Collection geoms, GeometryFactory geomFact) Computes the geometric union of aCollection
ofGeometry
s.static Geometry
Constructs a unary union operation for aGeometry
(which may be aGeometryCollection
).UnionInteracting.union()
static Geometry
private Geometry
CascadedPolygonUnion.unionActual
(Geometry g0, Geometry g1) Encapsulates the actual unioning of two polygonal geometries.private Geometry
UnaryUnionOp.unionNoOpt
(Geometry g0) Computes a unary union with no extra optimization, and no short-circuiting.private Geometry
CascadedPolygonUnion.unionOptimized
(Geometry g0, Geometry g1) private Geometry
Computes the union of two geometries, either or both of which may be null.private Geometry
private Geometry
CascadedPolygonUnion.unionUsingEnvelopeIntersection
(Geometry g0, Geometry g1, Envelope common) Unions two polygonal geometries, restricting computation to the envelope intersection where possible.private Geometry
UnaryUnionOp.unionWithNull
(Geometry g0, Geometry g1) Computes the union of two geometries, either of both of which may be null.Methods in org.locationtech.jts.operation.union with parameters of type GeometryModifier and TypeMethodDescriptionprivate Geometry
CascadedPolygonUnion.bufferUnion
(Geometry g0, Geometry g1) private Geometry
UnionInteracting.bufferUnion
(Geometry g0, Geometry g1) private boolean
UnionInteracting.computeInteracting
(Geometry elem0) private void
private Geometry
CascadedPolygonUnion.extractByEnvelope
(Envelope env, Geometry geom, List disjointGeoms) private Geometry
UnionInteracting.extractElements
(Geometry geom, boolean[] interacts, boolean isInteracting) private static Geometry
CascadedPolygonUnion.restrictToPolygons
(Geometry g) static Geometry
static Geometry
Constructs a unary union operation for aGeometry
(which may be aGeometryCollection
).static Geometry
private Geometry
CascadedPolygonUnion.unionActual
(Geometry g0, Geometry g1) Encapsulates the actual unioning of two polygonal geometries.private Geometry
UnaryUnionOp.unionNoOpt
(Geometry g0) Computes a unary union with no extra optimization, and no short-circuiting.private Geometry
CascadedPolygonUnion.unionOptimized
(Geometry g0, Geometry g1) private Geometry
Computes the union of two geometries, either or both of which may be null.private Geometry
CascadedPolygonUnion.unionUsingEnvelopeIntersection
(Geometry g0, Geometry g1, Envelope common) Unions two polygonal geometries, restricting computation to the envelope intersection where possible.private Geometry
UnaryUnionOp.unionWithNull
(Geometry g0, Geometry g1) Computes the union of two geometries, either of both of which may be null.Constructors in org.locationtech.jts.operation.union with parameters of type GeometryModifierConstructorDescriptionPointGeometryUnion
(Puntal pointGeom, Geometry otherGeom) UnaryUnionOp
(Geometry geom) Constructs a unary union operation for aGeometry
(which may be aGeometryCollection
).UnionInteracting
(Geometry g0, Geometry g1) -
Uses of Geometry in org.locationtech.jts.operation.valid
Fields in org.locationtech.jts.operation.valid declared as GeometryMethods in org.locationtech.jts.operation.valid with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
IsValidOp.checkValid
(Geometry g) boolean
RepeatedPointTester.hasRepeatedPoint
(Geometry g) static boolean
Tests whether aGeometry
is valid.private void
ConnectedInteriorTester.visitShellInteriors
(Geometry g, PlanarGraph graph) Mark all the edges for the edgeRings corresponding to the shells of the input polygons.Constructors in org.locationtech.jts.operation.valid with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.precision
Fields in org.locationtech.jts.precision declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
MinimumClearance.inputGeom
private Geometry
SimpleMinimumClearance.inputGeom
Methods in org.locationtech.jts.precision that return GeometryModifier and TypeMethodDescriptionComputes the buffer a geometry, using enhanced precision.static Geometry
Computes the buffer of aGeometry
, using enhanced precision.private Geometry
GeometryPrecisionReducer.changePM
(Geometry geom, PrecisionModel newPM) Duplicates a geometry to one that uses a different PrecisionModel, without changing any coordinate values.private Geometry
CommonBitsOp.computeResultPrecision
(Geometry result) If required, returning the result to the original precision if required.CommonBitsOp.difference
(Geometry geom0, Geometry geom1) Computes the set-theoretic difference of twoGeometry
s, using enhanced precision.static Geometry
EnhancedPrecisionOp.difference
(Geometry geom0, Geometry geom1) Computes the set-theoretic difference of twoGeometry
s, using enhanced precision.private Geometry
GeometryPrecisionReducer.fixPolygonalTopology
(Geometry geom) static Geometry
Gets a LineString containing two points which are at the Minimum Clearance distance for the given Geometry.static Geometry
CommonBitsOp.intersection
(Geometry geom0, Geometry geom1) Computes the set-theoretic intersection of twoGeometry
s, using enhanced precision.static Geometry
EnhancedPrecisionOp.intersection
(Geometry geom0, Geometry geom1) Computes the set-theoretic intersection of twoGeometry
s, using enhanced precision.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.Deprecated.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.private Geometry
GeometryPrecisionReducer.reducePointwise
(Geometry geom) 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.private Geometry
CommonBitsOp.removeCommonBits
(Geometry geom0) Computes a copy of the inputGeometry
with the calculated common bits removed from each coordinate.private Geometry[]
CommonBitsOp.removeCommonBits
(Geometry geom0, Geometry geom1) Computes a copy of each inputGeometry
s with the calculated common bits removed from each coordinate.CommonBitsRemover.removeCommonBits
(Geometry geom) Removes the common coordinate bits from a Geometry.CommonBitsOp.symDifference
(Geometry geom0, Geometry geom1) Computes the set-theoretic symmetric difference of two geometries, using enhanced precision.static Geometry
EnhancedPrecisionOp.symDifference
(Geometry geom0, Geometry geom1) Computes the set-theoretic symmetric difference of twoGeometry
s, using enhanced precision.Computes the set-theoretic union of twoGeometry
s, using enhanced precision.static Geometry
Computes the set-theoretic union of twoGeometry
s, using enhanced precision.Methods in org.locationtech.jts.precision with parameters of type GeometryModifier and TypeMethodDescriptionvoid
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.Computes the buffer a geometry, using enhanced precision.static Geometry
Computes the buffer of aGeometry
, using enhanced precision.private Geometry
GeometryPrecisionReducer.changePM
(Geometry geom, PrecisionModel newPM) Duplicates a geometry to one that uses a different PrecisionModel, without changing any coordinate values.private Geometry
CommonBitsOp.computeResultPrecision
(Geometry result) If required, returning the result to the original precision if required.CommonBitsOp.difference
(Geometry geom0, Geometry geom1) Computes the set-theoretic difference of twoGeometry
s, using enhanced precision.static Geometry
EnhancedPrecisionOp.difference
(Geometry geom0, Geometry geom1) Computes the set-theoretic difference of twoGeometry
s, using enhanced precision.PrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) SimpleGeometryPrecisionReducer.PrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) private Geometry
GeometryPrecisionReducer.fixPolygonalTopology
(Geometry geom) static double
MinimumClearance.getDistance
(Geometry g) Computes the Minimum Clearance distance for the given Geometry.static double
SimpleMinimumClearance.getDistance
(Geometry g) static Geometry
Gets a LineString containing two points which are at the Minimum Clearance distance for the given Geometry.static Geometry
CommonBitsOp.intersection
(Geometry geom0, Geometry geom1) Computes the set-theoretic intersection of twoGeometry
s, using enhanced precision.static Geometry
EnhancedPrecisionOp.intersection
(Geometry geom0, Geometry geom1) Computes the set-theoretic intersection of twoGeometry
s, using enhanced precision.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.Deprecated.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.private Geometry
GeometryPrecisionReducer.reducePointwise
(Geometry geom) 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.private Geometry
CommonBitsOp.removeCommonBits
(Geometry geom0) Computes a copy of the inputGeometry
with the calculated common bits removed from each coordinate.private Geometry[]
CommonBitsOp.removeCommonBits
(Geometry geom0, Geometry geom1) Computes a copy of each inputGeometry
s with the calculated common bits removed from each coordinate.CommonBitsRemover.removeCommonBits
(Geometry geom) Removes the common coordinate bits from a Geometry.CommonBitsOp.symDifference
(Geometry geom0, Geometry geom1) Computes the set-theoretic symmetric difference of two geometries, using enhanced precision.static Geometry
EnhancedPrecisionOp.symDifference
(Geometry geom0, Geometry geom1) Computes the set-theoretic symmetric difference of twoGeometry
s, using enhanced precision.Computes the set-theoretic union of twoGeometry
s, using enhanced precision.static Geometry
Computes the set-theoretic union of twoGeometry
s, using enhanced precision.Constructors in org.locationtech.jts.precision with parameters of type GeometryModifierConstructorDescriptionMinimumClearance
(Geometry geom) Creates an object to compute the Minimum Clearance for the given Geometry -
Uses of Geometry in org.locationtech.jts.shape
Methods in org.locationtech.jts.shape that return Geometry -
Uses of Geometry in org.locationtech.jts.shape.fractal
Methods in org.locationtech.jts.shape.fractal that return GeometryModifier and TypeMethodDescriptionKochSnowflakeBuilder.getGeometry()
SierpinskiCarpetBuilder.getGeometry()
-
Uses of Geometry in org.locationtech.jts.shape.random
Fields in org.locationtech.jts.shape.random declared as GeometryMethods in org.locationtech.jts.shape.random that return GeometryModifier and TypeMethodDescriptionRandomPointsBuilder.getGeometry()
RandomPointsInGridBuilder.getGeometry()
Gets theMultiPoint
containing the generated pointMethods in org.locationtech.jts.shape.random with parameters of type Geometry -
Uses of Geometry in org.locationtech.jts.simplify
Fields in org.locationtech.jts.simplify declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
DouglasPeuckerSimplifier.inputGeom
private Geometry
TopologyPreservingSimplifier.inputGeom
private Geometry
VWSimplifier.inputGeom
private Geometry
TaggedLineSegment.parent
Methods in org.locationtech.jts.simplify that return GeometryModifier and TypeMethodDescriptionprivate Geometry
DouglasPeuckerSimplifier.DPTransformer.createValidArea
(Geometry rawAreaGeom) Creates a valid area geometry from one that possibly has bad topology (i.e.private Geometry
VWSimplifier.VWTransformer.createValidArea
(Geometry rawAreaGeom) Creates a valid area geometry from one that possibly has bad topology (i.e.TaggedLineSegment.getParent()
DouglasPeuckerSimplifier.getResultGeometry()
Gets the simplified geometry.TopologyPreservingSimplifier.getResultGeometry()
VWSimplifier.getResultGeometry()
Gets the simplified geometry.static Geometry
Simplifies a geometry using a given tolerance.static Geometry
static Geometry
Simplifies a geometry using a given tolerance.protected Geometry
DouglasPeuckerSimplifier.DPTransformer.transformLinearRing
(LinearRing geom, Geometry parent) Simplifies a LinearRing.protected Geometry
VWSimplifier.VWTransformer.transformLinearRing
(LinearRing geom, Geometry parent) Simplifies a LinearRing.protected Geometry
DouglasPeuckerSimplifier.DPTransformer.transformMultiPolygon
(MultiPolygon geom, Geometry parent) Simplifies a MultiPolygon, fixing it if required.protected Geometry
VWSimplifier.VWTransformer.transformMultiPolygon
(MultiPolygon geom, Geometry parent) Simplifies a MultiPolygon, fixing it if required.protected Geometry
DouglasPeuckerSimplifier.DPTransformer.transformPolygon
(Polygon geom, Geometry parent) Simplifies a polygon, fixing it if required.protected Geometry
VWSimplifier.VWTransformer.transformPolygon
(Polygon geom, Geometry parent) Simplifies a polygon, fixing it if required.Methods in org.locationtech.jts.simplify with parameters of type GeometryModifier and TypeMethodDescriptionprivate Geometry
DouglasPeuckerSimplifier.DPTransformer.createValidArea
(Geometry rawAreaGeom) Creates a valid area geometry from one that possibly has bad topology (i.e.private Geometry
VWSimplifier.VWTransformer.createValidArea
(Geometry rawAreaGeom) Creates a valid area geometry from one that possibly has bad topology (i.e.void
Filters linear geometries.static Geometry
Simplifies a geometry using a given tolerance.static Geometry
static Geometry
Simplifies a geometry using a given tolerance.protected CoordinateSequence
DouglasPeuckerSimplifier.DPTransformer.transformCoordinates
(CoordinateSequence coords, Geometry parent) protected CoordinateSequence
TopologyPreservingSimplifier.LineStringTransformer.transformCoordinates
(CoordinateSequence coords, Geometry parent) protected CoordinateSequence
VWSimplifier.VWTransformer.transformCoordinates
(CoordinateSequence coords, Geometry parent) protected Geometry
DouglasPeuckerSimplifier.DPTransformer.transformLinearRing
(LinearRing geom, Geometry parent) Simplifies a LinearRing.protected Geometry
VWSimplifier.VWTransformer.transformLinearRing
(LinearRing geom, Geometry parent) Simplifies a LinearRing.protected Geometry
DouglasPeuckerSimplifier.DPTransformer.transformMultiPolygon
(MultiPolygon geom, Geometry parent) Simplifies a MultiPolygon, fixing it if required.protected Geometry
VWSimplifier.VWTransformer.transformMultiPolygon
(MultiPolygon geom, Geometry parent) Simplifies a MultiPolygon, fixing it if required.protected Geometry
DouglasPeuckerSimplifier.DPTransformer.transformPolygon
(Polygon geom, Geometry parent) Simplifies a polygon, fixing it if required.protected Geometry
VWSimplifier.VWTransformer.transformPolygon
(Polygon geom, Geometry parent) Simplifies a polygon, fixing it if required.Constructors in org.locationtech.jts.simplify with parameters of type GeometryModifierConstructorDescriptionDouglasPeuckerSimplifier
(Geometry inputGeom) Creates a simplifier for a given geometry.TaggedLineSegment
(Coordinate p0, Coordinate p1, Geometry parent, int index) TopologyPreservingSimplifier
(Geometry inputGeom) VWSimplifier
(Geometry inputGeom) Creates a simplifier for a given geometry. -
Uses of Geometry in org.locationtech.jts.triangulate
Fields in org.locationtech.jts.triangulate declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
ConformingDelaunayTriangulationBuilder.constraintLines
private Geometry
ConformingDelaunayTriangulator.convexHull
Methods in org.locationtech.jts.triangulate that return GeometryModifier and TypeMethodDescriptionprivate static Geometry
VoronoiDiagramBuilder.clipGeometryCollection
(Geometry geom, Envelope clipEnv) ConformingDelaunayTriangulator.getConvexHull()
Gets the convex hull of all the sites in the triangulation, including constraint vertices.VoronoiDiagramBuilder.getDiagram
(GeometryFactory geomFact) Gets the faces of the computed diagram as aGeometryCollection
ofPolygon
s, clipped as specified.ConformingDelaunayTriangulationBuilder.getEdges
(GeometryFactory geomFact) Gets the edges of the computed triangulation as aMultiLineString
.DelaunayTriangulationBuilder.getEdges
(GeometryFactory geomFact) Gets the edges of the computed triangulation as aMultiLineString
.ConformingDelaunayTriangulationBuilder.getTriangles
(GeometryFactory geomFact) Gets the faces of the computed triangulation as aGeometryCollection
ofPolygon
.DelaunayTriangulationBuilder.getTriangles
(GeometryFactory geomFact) Gets the faces of the computed triangulation as aGeometryCollection
ofPolygon
.Methods in org.locationtech.jts.triangulate with parameters of type GeometryModifier and TypeMethodDescriptionprivate static Geometry
VoronoiDiagramBuilder.clipGeometryCollection
(Geometry geom, Envelope clipEnv) private static List
ConformingDelaunayTriangulationBuilder.createConstraintSegments
(Geometry geom) private void
ConformingDelaunayTriangulationBuilder.createVertices
(Geometry geom) static CoordinateList
DelaunayTriangulationBuilder.extractUniqueCoordinates
(Geometry geom) Extracts the uniqueCoordinate
s from the givenGeometry
.void
VertexTaggedGeometryDataMapper.loadSourceGeometries
(Geometry geomColl) void
ConformingDelaunayTriangulationBuilder.setConstraints
(Geometry constraintLines) Sets the linear constraints to be conformed to.void
Sets the sites (point or vertices) which will be triangulated.void
Sets the sites (vertices) which will be triangulated.void
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. -
Uses of Geometry in org.locationtech.jts.triangulate.quadedge
Methods in org.locationtech.jts.triangulate.quadedge that return GeometryModifier and TypeMethodDescriptionQuadEdgeSubdivision.getEdges
(GeometryFactory geomFact) Gets the geometry for the edges in the subdivision as aMultiLineString
containing 2-point lines.QuadEdgeSubdivision.getTriangles
(GeometryFactory geomFact) Gets the geometry for the triangles in a triangulated subdivision as aGeometryCollection
of triangularPolygon
s.QuadEdgeSubdivision.getVoronoiDiagram
(GeometryFactory geomFact) Gets the cells in the Voronoi diagram for this triangulation.static Geometry
static Geometry
-
Uses of Geometry in org.locationtech.jts.util
Methods in org.locationtech.jts.util that return GeometryMethods in org.locationtech.jts.util with parameters of type GeometryModifier and TypeMethodDescriptionstatic boolean
Debug.hasSegment
(Geometry geom, Coordinate p0, Coordinate p1) protected Geometry
-
Uses of Geometry in org.locationtech.jtsexample.geom.prep
Methods in org.locationtech.jtsexample.geom.prep that return GeometryModifier and TypeMethodDescription(package private) static Geometry
PreparedGeometryExample.createCircle()
-
Uses of Geometry in org.locationtech.jtsexample.operation.linemerge
Methods in org.locationtech.jtsexample.operation.linemerge that return Geometry -
Uses of Geometry in org.locationtech.jtsexample.technique
Methods in org.locationtech.jtsexample.technique that return GeometryModifier and TypeMethodDescription(package private) static Geometry
SearchUsingPreparedGeometryIndex.createCircle
(Coordinate centre, double radius) static Geometry
LineStringSelfIntersections.getEndPoints
(Geometry g) static Geometry
LineStringSelfIntersections.lineStringSelfIntersections
(LineString line) Methods in org.locationtech.jtsexample.technique with parameters of type GeometryModifier and TypeMethodDescription(package private) static List
SearchUsingPreparedGeometryIndex.findIntersecting
(Collection targetGeoms, Geometry queryGeom) static Geometry
LineStringSelfIntersections.getEndPoints
(Geometry g) PreparedGeometryIndex.intersects
(Geometry g) Finds allPreparedGeometry
s which intersect a givenGeometry
Finds allPreparedGeometry
s which might interact with a queryGeometry
.static void
PolygonUnionUsingBuffer.unionUsingBuffer
(Geometry[] geom) Deprecated. -
Uses of Geometry in org.locationtech.jtstest.clean
Methods in org.locationtech.jtstest.clean that return GeometryMethods in org.locationtech.jtstest.clean with parameters of type Geometry -
Uses of Geometry in org.locationtech.jtstest.function
Methods in org.locationtech.jtstest.function that return GeometryModifier and TypeMethodDescriptionstatic Geometry
TriangleFunctions.angleBisectors
(Geometry g) static Geometry
SelectionFunctions.areaGreaterThan
(Geometry a, double minArea) static Geometry
SelectionFunctions.areaLessThan
(Geometry a, double maxArea) static Geometry
static Geometry
static Geometry
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
static Geometry
BufferFunctions.bufferAndInverse
(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) private static Geometry
BufferFunctions.buildBufferLineSimplifiedSet
(Geometry g, double distance) private static Geometry
BufferFunctions.buildCurveSet
(Geometry g, double dist, BufferParameters bufParams) static Geometry
FunctionsUtil.buildGeometry
(List geoms, Geometry parentGeom) static Geometry
FunctionsUtil.buildGeometry
(Geometry[] geoms) static Geometry
FunctionsUtil.buildGeometry
(Geometry a, Geometry b) static Geometry
static Geometry
static Geometry
TriangleFunctions.circumcentre
(Geometry g) static Geometry
static Geometry
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
static Geometry
private static Geometry
private static Geometry
private static Geometry
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
static Geometry
static Geometry
OverlayCommonBitsRemovedFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayNoSnapFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayCommonBitsRemovedFunctions.differenceBA
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.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
static Geometry
static Geometry
static Geometry
static Geometry
CreateShapeFunctions.ellipseRotate
(Geometry g, int nPts, double ang) static Geometry
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) private static Geometry
static Geometry
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
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
static Geometry
ConstructionFunctions.interiorPoint
(Geometry g) static Geometry
OverlayCommonBitsRemovedFunctions.intersection
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.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
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
SelectionFunctions.lengthGreaterThan
(Geometry a, double minLen) static Geometry
SelectionFunctions.lengthLessThan
(Geometry a, double maxLen) static Geometry
SelectionFunctions.lengthZero
(Geometry a) static Geometry
JTSFunctions.logoBuffer
(Geometry g, double distance) static Geometry
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
PrecisionFunctions.minClearanceLine
(Geometry g) static Geometry
TestCaseGeometryFunctions.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
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) private static Geometry
PolygonizeFunctions.polygonize
(Geometry g, boolean extractOnlyPolygonal) 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
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
static Geometry
static Geometry
AffineTransformationFunctions.rotateAroundPoint
(Geometry g, Geometry pt, double angle) static Geometry
AffineTransformationFunctions.rotateByPiMultiple
(Geometry g, double multipleOfPi) static Geometry
AffineTransformationFunctions.rotateByPiMultipleAroundPoint
(Geometry g, Geometry pt, double multipleOfPi) static Geometry
static Geometry
NodingFunctions.scaledNoding
(Geometry geom, double scaleFactor) Runs a ScaledNoder on input.static Geometry
LineSegmentFunctions.segmentIntersection
(Geometry g1, Geometry g2) static Geometry
LineSegmentFunctions.segmentIntersectionDD
(Geometry g1, Geometry g2) private static Geometry
SelectionFunctions.select
(Geometry geom, GeometryPredicate pred) 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
static Geometry
BufferFunctions.singleSidedBuffer
(Geometry geom, double distance) static Geometry
BufferFunctions.singleSidedBufferCurve
(Geometry geom, double distance) static Geometry
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
static Geometry
SpatialIndexFunctions.strTreeBounds
(Geometry geoms) static Geometry
static Geometry
SpatialIndexFunctions.strTreeNNk
(Geometry geoms, Geometry geom, int k) 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
OverlayCommonBitsRemovedFunctions.symDifference
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.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
static Geometry
ConversionFunctions.toMultiPolygon
(Geometry g1, Geometry g2) static Geometry
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
static Geometry
static Geometry
static Geometry
static Geometry
OverlayFunctions.unionUsingGeometryCollection
(Geometry a, Geometry b) static Geometry
static Geometry
static Geometry
TriangulationFunctions.voronoiDiagram
(Geometry sitesGeom, Geometry clipGeom) static Geometry
TriangulationFunctions.voronoiDiagramWithData
(Geometry sitesGeom, Geometry clipGeom) static Geometry
Methods in org.locationtech.jtstest.function with parameters of type GeometryModifier and TypeMethodDescriptionprivate static void
ConversionFunctions.addComponents
(Geometry g, List atomicGeoms) static Geometry
TriangleFunctions.angleBisectors
(Geometry g) static double
static Geometry
SelectionFunctions.areaGreaterThan
(Geometry a, double minArea) static Geometry
SelectionFunctions.areaLessThan
(Geometry a, double maxArea) static Geometry
static Geometry
static Geometry
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
static Geometry
BufferFunctions.bufferAndInverse
(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) private static Geometry
BufferFunctions.buildBufferLineSimplifiedSet
(Geometry g, double distance) private static Geometry
BufferFunctions.buildCurveSet
(Geometry g, double dist, BufferParameters bufParams) static Geometry
FunctionsUtil.buildGeometry
(List geoms, Geometry parentGeom) static Geometry
FunctionsUtil.buildGeometry
(Geometry[] geoms) static Geometry
FunctionsUtil.buildGeometry
(Geometry a, Geometry b) private static KdTree
SpatialIndexFunctions.buildKdTree
(Geometry geom, double tolerance) private static Quadtree
SpatialIndexFunctions.buildQuadtree
(Geometry geom) private static STRtree
SpatialIndexFunctions.buildSTRtree
(Geometry geom) static Geometry
static Geometry
static Geometry
TriangleFunctions.circumcentre
(Geometry g) static Geometry
static Geometry
static Geometry
BufferByUnionFunctions.componentBuffers
(Geometry g, double distance) private static List
SortingFunctions.components
(Geometry g) 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
static Geometry
GeometryFunctions.convertToPolygon
(Geometry g) static Geometry
ConstructionFunctions.convexHull
(Geometry g) static Geometry
static boolean
static Geometry
static boolean
private static Geometry
private static Geometry
private static Geometry
private static PreparedGeometry
private static List
NodingFunctions.createSegmentStrings
(Geometry geom) static boolean
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
static Geometry
static Geometry
OverlayCommonBitsRemovedFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayNoSnapFunctions.difference
(Geometry a, Geometry b) static Geometry
OverlayCommonBitsRemovedFunctions.differenceBA
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.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
static boolean
static Geometry
static Geometry
static double
static Geometry
static Geometry
CreateShapeFunctions.ellipseRotate
(Geometry g, int nPts, double ang) static Geometry
private static Coordinate
AffineTransformationFunctions.envelopeCentre
(Geometry g) private static Coordinate
AffineTransformationFunctions.envelopeLowerLeft
(Geometry g) static boolean
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) private static Geometry
static Geometry
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) (package private) static Coordinate[]
static Geometry
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
static int
NodingFunctions.interiorIntersectionCount
(Geometry geom) static Geometry
ConstructionFunctions.interiorPoint
(Geometry g) static Geometry
OverlayCommonBitsRemovedFunctions.intersection
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.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 Geometry
static Geometry
ValidationFunctions.invalidGeoms
(Geometry g) static Geometry
ValidationFunctions.invalidLocations
(Geometry g) Validates all geometries in a collection independently.static boolean
static boolean
static boolean
NodingFunctions.isNodingValid
(Geometry geom) static boolean
PointLocationFunctions.isPointInRing
(Geometry g1, Geometry g2) static boolean
GeometryFunctions.isRectangle
(Geometry g) static boolean
boolean
static boolean
static boolean
ValidationFunctions.isValidAllowSelfTouchingRingFormingHole
(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
static Geometry
SelectionFunctions.lengthGreaterThan
(Geometry a, double minLen) static Geometry
SelectionFunctions.lengthLessThan
(Geometry a, double maxLen) static Geometry
SelectionFunctions.lengthZero
(Geometry a) static Geometry
JTSFunctions.logoBuffer
(Geometry g, double distance) static Geometry
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
PrecisionFunctions.minClearance
(Geometry g) static double
TestCaseGeometryFunctions.minClearance
(Geometry g) static Geometry
PrecisionFunctions.minClearanceLine
(Geometry g) static Geometry
TestCaseGeometryFunctions.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
static Geometry
ConstructionFunctions.octagonalEnvelope
(Geometry g) static Geometry
OffsetCurveFunctions.offsetCurve
(Geometry geom, double distance) static int
OrientationFunctions.orientationIndex
(Geometry segment, Geometry ptGeom) static boolean
static Geometry
PolygonOverlayFunctions.overlaySnapRounded
(Geometry g1, Geometry g2, double precisionTol) static Geometry
TriangleFunctions.perpendicularBisectors
(Geometry g) static Geometry
PolygonizeFunctions.polygonize
(Geometry g) private static Geometry
PolygonizeFunctions.polygonize
(Geometry g, boolean extractOnlyPolygonal) 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.preparedContains
(Geometry g1, Geometry g2) static boolean
PreparedGeometryFunctions.preparedContainsProperly
(Geometry g1, Geometry g2) static boolean
PreparedGeometryFunctions.preparedCovers
(Geometry g1, Geometry g2) static boolean
PreparedGeometryFunctions.preparedIntersects
(Geometry g1, Geometry g2) static Geometry
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
static Geometry
static Geometry
static Geometry
AffineTransformationFunctions.rotateAroundPoint
(Geometry g, Geometry pt, double angle) static Geometry
AffineTransformationFunctions.rotateByPiMultiple
(Geometry g, double multipleOfPi) static Geometry
AffineTransformationFunctions.rotateByPiMultipleAroundPoint
(Geometry g, Geometry pt, double multipleOfPi) static Geometry
static Geometry
NodingFunctions.scaledNoding
(Geometry geom, double scaleFactor) Runs a ScaledNoder on input.static Geometry
LineSegmentFunctions.segmentIntersection
(Geometry g1, Geometry g2) static Geometry
LineSegmentFunctions.segmentIntersectionDD
(Geometry g1, Geometry g2) static boolean
LineSegmentFunctions.segmentIntersects
(Geometry g1, Geometry g2) private static Geometry
SelectionFunctions.select
(Geometry geom, GeometryPredicate pred) 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
static Geometry
BufferFunctions.singleSidedBuffer
(Geometry geom, double distance) static Geometry
BufferFunctions.singleSidedBufferCurve
(Geometry geom, double distance) static Geometry
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
static Geometry
SpatialIndexFunctions.strTreeBounds
(Geometry geoms) static Geometry
static Geometry
SpatialIndexFunctions.strTreeNNk
(Geometry geoms, Geometry geom, int k) 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
OverlayCommonBitsRemovedFunctions.symDifference
(Geometry a, Geometry b) static Geometry
OverlayEnhancedPrecisionFunctions.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
static Geometry
ConversionFunctions.toMultiPolygon
(Geometry g1, Geometry g2) static Geometry
static boolean
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) private static Coordinate[]
TriangleFunctions.trianglePts
(Geometry g) static Geometry
OverlayFunctions.unaryUnion
(Geometry a) static Geometry
static Geometry
static Geometry
static Geometry
static Geometry
OverlayFunctions.unionUsingGeometryCollection
(Geometry a, Geometry b) static Geometry
static Geometry
static Geometry
TriangulationFunctions.voronoiDiagram
(Geometry sitesGeom, Geometry clipGeom) static Geometry
TriangulationFunctions.voronoiDiagramWithData
(Geometry sitesGeom, Geometry clipGeom) static Geometry
static boolean
static String
WriterFunctions.writeGeoJSON
(Geometry g) static String
WriterFunctions.writeGeoJSONFixDecimal
(Geometry g, int numDecimals) static String
static String
static String
static String
-
Uses of Geometry in org.locationtech.jtstest.geomfunction
Methods in org.locationtech.jtstest.geomfunction with parameters of type GeometryModifier and TypeMethodDescriptionprivate static Object[]
StaticMethodGeometryFunction.createFullArgs
(Geometry g, Object[] arg) Creates an arg array which includes the target geometry as the first argumentabstract Object
Invokes this function.private Object
RepeaterGeometryFunction.invokeRepeated
(Geometry geom, Object[] args, double argStart) -
Uses of Geometry in org.locationtech.jtstest.geomop
Methods in org.locationtech.jtstest.geomop that return GeometryModifier and TypeMethodDescriptionstatic Geometry
TestCaseGeometryFunctions.bufferMitredJoin
(Geometry g, double distance) static Geometry
private Geometry
BufferValidatedGeometryOperation.invokeBuffer
(Geometry geom) static Geometry
OverlayValidatedGeometryOperation.invokeGeometryOverlayMethod
(int opCode, Geometry g0, Geometry g1) static Geometry
TestCaseGeometryFunctions.minClearanceLine
(Geometry g) Methods in org.locationtech.jtstest.geomop with parameters of type GeometryModifier and TypeMethodDescriptionstatic double
private void
OverlayValidatedGeometryOperation.areaValidate
(Geometry g0, Geometry g1) static Geometry
TestCaseGeometryFunctions.bufferMitredJoin
(Geometry g, double distance) private void
PreparedGeometryTeeOperation.checkAllPrepOps
(Geometry g1, Geometry g2) private void
BufferValidatedGeometryOperation.checkContainment
(Geometry geom, Geometry buffer) private void
PreparedGeometryTeeOperation.checkContains
(PreparedGeometry pg, Geometry g2) private void
PreparedGeometryTeeOperation.checkContainsProperly
(PreparedGeometry pg, Geometry g2) private void
PreparedGeometryTeeOperation.checkCovers
(PreparedGeometry pg, Geometry g2) private void
BufferValidatedGeometryOperation.checkDistance
(Geometry geom, double distance, Geometry buffer) private void
BufferValidatedGeometryOperation.checkEmpty
(Geometry geom) private void
PreparedGeometryTeeOperation.checkIntersects
(PreparedGeometry pg, Geometry g2) static boolean
static boolean
static boolean
PreparedGeometryOperation.PreparedGeometryOp.containsProperly
(Geometry g1, Geometry g2) private static boolean
PreparedGeometryTeeOperation.containsProperly
(Geometry g1, Geometry g2) static boolean
static boolean
private static Object[]
StaticMethodGeometryFunction.createFullArgs
(Geometry g, Object[] arg) Creates an arg array which includes the target geometry as the first argumentstatic Geometry
static boolean
PreparedGeometryOperation.PreparedGeometryOp.intersects
(Geometry g1, Geometry g2) static boolean
PreparedGeometryTeeOperation.PreparedGeometryOp.intersects
(Geometry g1, Geometry g2) abstract Object
Invokes the named operationInvokes this function.private Result
GeometryFunctionOperation.invoke
(GeometryFunction func, Geometry geometry, Object[] args) Invokes an operation on aGeometry
.Invokes the named operationInvokes the named operationInvokes the named operationprivate Geometry
BufferValidatedGeometryOperation.invokeBuffer
(Geometry geom) private Result
BufferValidatedGeometryOperation.invokeBufferOpValidated
(Geometry geometry, Object[] args) static Geometry
OverlayValidatedGeometryOperation.invokeGeometryOverlayMethod
(int opCode, Geometry g0, Geometry g1) private Result
GeometryMethodOperation.invokeMethod
(Method method, Geometry geometry, Object[] args) private Result
PreparedGeometryOperation.invokePreparedOp
(String opName, Geometry geometry, Object[] args) OverlayValidatedGeometryOperation.invokeValidatedOverlayOp
(int opCode, Geometry g0, Object[] args) Invokes an overlay op, optionally using snapping, and optionally validating the result.private boolean
BufferValidatedGeometryOperation.isEmptyBufferExpected
(Geometry geom) boolean
boolean
static double
TestCaseGeometryFunctions.minClearance
(Geometry g) static Geometry
TestCaseGeometryFunctions.minClearanceLine
(Geometry g) protected void
protected abstract void
private void
private void
-
Uses of Geometry in org.locationtech.jtstest.test
Fields in org.locationtech.jtstest.test declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
TestCase.expectedBoundary
private Geometry
TestCase.expectedCentroid
private Geometry
TestCase.expectedConvexHull
private Geometry
TestCase.expectedDifference
private Geometry
TestCase.expectedIntersection
private Geometry
TestCase.expectedSymDifference
private Geometry
TestCase.expectedUnion
private Geometry[]
TestCase.geom
Methods in org.locationtech.jtstest.test that return GeometryModifier and TypeMethodDescriptionTestCase.getExpectedBoundary()
TestCase.getExpectedConvexHull()
TestCase.getExpectedDifference()
TestCase.getExpectedIntersection()
TestCase.getExpectedSymDifference()
TestCase.getExpectedUnion()
Geometry[]
TestCase.getGeometries()
Testable.getGeometry
(int index) TestCase.getGeometry
(int index) private Geometry
TestCase.toNullOrGeometry
(String wellKnownText) Methods in org.locationtech.jtstest.test with parameters of type GeometryModifier and TypeMethodDescription(package private) void
TestCase.assertEqualsExact
(Geometry g1, Geometry g2, String msg) (package private) void
TestCase.init
(String name, String description, String wkta, String wktb, String expectedIM, Geometry expectedConvexHull, Geometry expectedIntersection, Geometry expectedUnion, Geometry expectedDifference, Geometry expectedSymDifference, Geometry expectedBoundary) (package private) IntersectionMatrix
void
TestCase.setExpectedBoundary
(Geometry expectedBoundary) void
TestCase.setExpectedCentroid
(Geometry expectedCentroid) void
TestCase.setExpectedConvexHull
(Geometry expectedConvexHull) void
TestCase.setExpectedDifference
(Geometry expectedDifference) void
TestCase.setExpectedIntersection
(Geometry expectedIntersection) void
TestCase.setExpectedSymDifference
(Geometry expectedSymDifference) void
TestCase.setExpectedUnion
(Geometry expectedUnion) void
Testable.setGeometry
(int index, Geometry g) void
TestCase.setGeometry
(int index, Geometry g) -
Uses of Geometry in org.locationtech.jtstest.testbuilder
Fields in org.locationtech.jtstest.testbuilder declared as GeometryMethods in org.locationtech.jtstest.testbuilder that return GeometryModifier and TypeMethodDescriptionprivate Geometry
GeometryEditPanel.flashPointGeom
(Geometry g) CoordinateNode.getGeometry()
abstract Geometry
GeometricObjectNode.getGeometry()
GeometryCollectionNode.getGeometry()
(package private) Geometry
GeometryInputDialog.getGeometry
(int index) LineStringNode.getGeometry()
PointNode.getGeometry()
PolygonNode.getGeometry()
private static Geometry
GeometryTreePanel.getGeometryFromNode
(Object value) GeometryTreePanel.getSelectedGeometry()
(package private) Geometry
GeometryInputDialog.parseGeometry
(JTextComponent txt, Color clr) Methods in org.locationtech.jtstest.testbuilder with parameters of type GeometryModifier and TypeMethodDescriptionprivate static double
private String
TestCaseTextDialog.convertToGML
(Geometry g) private String
TestCaseTextDialog.convertToWKB
(Geometry g) private String
TestCaseTextDialog.convertToWKT
(Geometry g, boolean isFormatted) static GeometryNode
GeometryNode.create
(Geometry geom, GeometryContext context) void
private Geometry
GeometryEditPanel.flashPointGeom
(Geometry g) private String
TestListPanel.TestListCellRenderer.geometrySignature
(Geometry geom) private static String
GeometryNode.geometryText
(Geometry geom, int size, String tag) private static boolean
private static boolean
private Coordinate
JTSTestBuilderFrame.pickOffset
(Geometry a, Geometry b) void
void
GeometryInspectorDialog.setGeometry
(String tag, Geometry geometry) void
InspectorPanel.setGeometry
(String tag, Geometry a, int source) private void
ResultWKTPanel.setGeometry
(Geometry g) void
private void
StatsPanel.writeGeomStats
(String label, Geometry g, StringBuffer buf) void
Constructors in org.locationtech.jtstest.testbuilder with parameters of type GeometryModifierConstructorDescriptionGeometryNode
(Geometry geom, int size, String tag, GeometryContext context) GeometryNode
(Geometry geom, GeometryContext context) GeometryTreeModel
(Geometry geom, int source) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.controller
Methods in org.locationtech.jtstest.testbuilder.controller that return GeometryModifier and TypeMethodDescriptionstatic Geometry
JTSTestBuilderController.getGeometryA()
static Geometry
JTSTestBuilderController.getGeometryB()
Methods in org.locationtech.jtstest.testbuilder.controller with parameters of type GeometryModifier and TypeMethodDescriptionstatic void
JTSTestBuilderController.addTestCase
(Geometry[] geom, String name) static void
JTSTestBuilderController.extractComponentsToTestCase
(Geometry aoi) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.geom
Fields in org.locationtech.jtstest.testbuilder.geom declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
ComponentLocater.aoi
private Geometry
GeometryLocation.component
The Geometry component containing the locationprivate Geometry
GeometryPointLocater.NearestSegmentLocationFilter.component
private Geometry
AdjacentVertexFinder.geom
private Geometry
GeometryPointLocater.geom
private Geometry
NearestPointFinder.geom
private Geometry
VertexLocater.geom
private Geometry
GeometryLocation.parent
The top-level geometry containing the locationprivate Geometry
ComponentLocater.parentGeom
private Geometry
FacetLocater.parentGeom
Methods in org.locationtech.jtstest.testbuilder.geom that return GeometryModifier and TypeMethodDescriptionGeometryCombiner.addLineString
(Geometry orig, Coordinate[] pts) GeometryCombiner.addPoint
(Geometry orig, Coordinate pt) GeometryCombiner.addPolygonRing
(Geometry orig, Coordinate[] pts) private Geometry
ComponentLocater.createAOI
(Coordinate queryPt, double tolerance) static Geometry
GeometryLocation.delete()
static Geometry
GeometryVertexDeleter.delete
(Geometry geom, LineString line, int vertexIndex) private static Geometry
GeometryBoxDeleter.deleteComponents
(Geometry geom, Envelope env) private static Geometry
GeometryBoxDeleter.deleteVertices
(Geometry geom, Envelope env) GeometryBoxDeleter.BoxDeleteComponentOperation.edit
(Geometry geometry, GeometryFactory factory) GeometryLocation.getComponent()
GeometryPointLocater.NearestSegmentLocationFilter.getComponent()
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
Methods in org.locationtech.jtstest.testbuilder.geom with parameters of type GeometryModifier and TypeMethodDescriptionGeometryCombiner.addLineString
(Geometry orig, Coordinate[] pts) GeometryCombiner.addPoint
(Geometry orig, Coordinate pt) GeometryCombiner.addPolygonRing
(Geometry orig, Coordinate[] pts) static Geometry
static Geometry
GeometryVertexDeleter.delete
(Geometry geom, LineString line, int vertexIndex) private static Geometry
GeometryBoxDeleter.deleteComponents
(Geometry geom, Envelope env) private static Geometry
GeometryBoxDeleter.deleteVertices
(Geometry geom, Envelope env) GeometryBoxDeleter.BoxDeleteComponentOperation.edit
(Geometry geometry, GeometryFactory factory) GeometryBoxDeleter.BoxDeleteVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexDeleter.DeleteVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexInserter.InsertVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexMover.MoveVertexOperation.edit
(Coordinate[] coords, Geometry geometry) static List
GeometryCombiner.extractElements
(Geometry geom, boolean skipEmpty) void
private void
ComponentLocater.findComponents
(Stack path, Geometry geom, List components) private void
FacetLocater.findLocations
(Stack path, Geometry geom, List locations) private void
FacetLocater.findLocations
(Stack path, Geometry compGeom, CoordinateSequence seq, List locations) private void
FacetLocater.findLocations
(Geometry geom, List locations) static Coordinate
NearestPointFinder.findNearestPoint
(Geometry geom, Coordinate pt, double tolerance) private static Polygon
GeometryCombiner.findPolygonContaining
(Geometry geom, Coordinate pt) private void
FacetLocater.findSegmentLocations
(Stack path, Geometry compGeom, CoordinateSequence seq, List locations) private void
FacetLocater.findVertexLocations
(Stack path, Geometry compGeom, CoordinateSequence seq, List locations) static Coordinate[]
AdjacentVertexFinder.findVertices
(Geometry geom, Coordinate testPt) 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
static String
GeometryUtil.structureSummary
(Geometry g) Constructors in org.locationtech.jtstest.testbuilder.geom with parameters of type GeometryModifierConstructorDescriptionAdjacentVertexFinder
(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) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.io.shapefile
Methods in org.locationtech.jtstest.testbuilder.io.shapefile that return GeometryModifier and TypeMethodDescriptionShapefile.next()
Returns the next geometry in the shapefile streamMultiLineHandler.read
(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength) MultiPointHandler.read
(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength) PointHandler.read
(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength) PolygonHandler.read
(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength) ShapeHandler.read
(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength) Methods in org.locationtech.jtstest.testbuilder.io.shapefile with parameters of type GeometryModifier and TypeMethodDescriptionint
int
Calcuates the record length of this object.int
Calcuates the record length of this object.int
int
static ShapeHandler
Shapefile.getShapeHandler
(Geometry geom, int ShapeFileDimentions) static int
Shapefile.getShapeType
(Geometry geom, int coordDimension) (package private) double[]
(package private) double[]
(package private) double[]
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.model
Fields in org.locationtech.jtstest.testbuilder.model declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
GeometryTransferable.geom
private Geometry[]
TestCaseEdit.geom
private Geometry
StaticGeometryContainer.geometry
private Geometry
TestCaseEdit.resultGeom
private Geometry[]
GeometryStretcherView.stretchGeom
Methods in org.locationtech.jtstest.testbuilder.model that return GeometryModifier and TypeMethodDescriptionprivate static Geometry
TestCaseEdit.cloneGeometry
(Geometry geom) private Geometry
LayerList.extractComponents
(Geometry parentGeom, Geometry aoi) LayerList.getComponent
(Coordinate pt, double tolerance) Geometry[]
LayerList.getComponents
(Geometry aoi) TestRunnerTestCaseAdapter.getExpectedBoundary()
TestRunnerTestCaseAdapter.getExpectedConvexHull()
TestRunnerTestCaseAdapter.getExpectedDifference()
TestRunnerTestCaseAdapter.getExpectedIntersection()
TestRunnerTestCaseAdapter.getExpectedSymDifference()
TestRunnerTestCaseAdapter.getExpectedUnion()
Geometry[]
TestCaseEdit.getGeometries()
GeometryContainer.getGeometry()
GeometryEditModel.getGeometry()
GeometryEditModel.getGeometry
(int i) GeometryStretcherView.StretchedGeometryContainer.getGeometry()
IndexedGeometryContainer.getGeometry()
Layer.getGeometry()
ResultGeometryContainer.getGeometry()
StaticGeometryContainer.getGeometry()
TestCaseEdit.getGeometry
(int i) TestRunnerTestCaseAdapter.getGeometry
(int index) GeometryEditModel.getResult()
TestCaseEdit.getResult()
GeometryStretcherView.getStretchedGeometry
(int index) private Geometry
TestBuilderModel.readGeometryText
(String geomStr) TestRunnerTestCaseAdapter.toGeometry
(Test test) Methods in org.locationtech.jtstest.testbuilder.model with parameters of type GeometryModifier and TypeMethodDescriptionvoid
void
private static Geometry
TestCaseEdit.cloneGeometry
(Geometry geom) private void
HtmlWriter.createGifFile
(String filenameNoPath, Geometry a, Geometry b, Geometry spatialFunction, boolean showingAB, int imageWidth, int imageHeight) private void
HtmlWriter.createGifFile
(String filenameNoPath, Geometry a, Geometry b, Geometry result, boolean showingAB, int imageWidth, int imageHeight, boolean zoomToFullExtent) private void
PNGWriter.createPNGFile
(String filenameNoPath, Geometry a, Geometry b, Geometry result, int imageWidth, int imageHeight) private Geometry
LayerList.extractComponents
(Geometry parentGeom, Geometry aoi) Geometry[]
LayerList.getComponents
(Geometry aoi) private static String
XMLTestWriter.getGeometryArgPairCode
(Geometry geom0, Geometry geom1) private static String
XMLTestWriter.getGeometryCode
(Geometry geom) TestBuilderModel.getResultDisplayString
(Geometry g) XMLTestWriter.getTestXML
(Geometry geometry, String opName, String[] arguments, boolean useWKT) static String
private String
XMLTestWriter.getWKTorWKB
(Geometry g, boolean useWKT) void
TestRunnerTestCaseAdapter.setExpectedBoundary
(Geometry expectedBoundary) void
TestRunnerTestCaseAdapter.setExpectedCentroid
(Geometry expected) void
TestRunnerTestCaseAdapter.setExpectedConvexHull
(Geometry expectedConvexHull) void
TestRunnerTestCaseAdapter.setExpectedDifference
(Geometry expectedDifference) void
TestRunnerTestCaseAdapter.setExpectedIntersection
(Geometry expectedIntersection) private void
TestRunnerTestCaseAdapter.setExpectedSpatialFunction
(String opName, Geometry expectedGeometry) void
TestRunnerTestCaseAdapter.setExpectedSymDifference
(Geometry expectedSymDifference) void
TestRunnerTestCaseAdapter.setExpectedUnion
(Geometry expectedUnion) void
GeometryEditModel.setGeometry
(int i, Geometry g) void
GeometryEditModel.setGeometry
(Geometry g) void
TestCaseEdit.setGeometry
(int i, Geometry geom) void
TestRunnerTestCaseAdapter.setGeometry
(int index, Geometry g) void
static String
GeometryEditModel.toStringVeryLarge
(Geometry g) private String
private String
private String
SVGTestWriter.writeGeometryStyled
(Geometry g, String fillClr, String strokeClr) Constructors in org.locationtech.jtstest.testbuilder.model with parameters of type GeometryModifierConstructorDescriptionGeometryTransferable
(Geometry geom) GeometryTransferable
(Geometry geom, boolean isFormatted) StaticGeometryContainer
(Geometry geometry) TestCaseEdit
(Geometry[] geom) TestCaseEdit
(Geometry[] geom, String name) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.topostretch
Fields in org.locationtech.jtstest.testbuilder.topostretch declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
GeometryVerticesMover.geom
private Geometry[]
TopologyStretcher.inputGeoms
Methods in org.locationtech.jtstest.testbuilder.topostretch that return GeometryModifier and TypeMethodDescriptionGeometryVerticesMover.move()
static Geometry
Geometry[]
TopologyStretcher.stretch
(double nearnessTol, double stretchDistance) Geometry[]
Methods in org.locationtech.jtstest.testbuilder.topostretch with parameters of type GeometryModifier and TypeMethodDescriptionGeometryVerticesMover.MoveVerticesOperation.edit
(Coordinate[] coords, Geometry geometry) private List
TopologyStretcher.extractLineStrings
(Geometry[] geom, Envelope mask) static Geometry
Constructors in org.locationtech.jtstest.testbuilder.topostretch with parameters of type GeometryModifierConstructorDescriptionGeometryVerticesMover
(Geometry geom, Map moves) TopologyStretcher
(Geometry g1, Geometry g2) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.ui
Methods in org.locationtech.jtstest.testbuilder.ui with parameters of type GeometryModifier and TypeMethodDescriptionGeometryLocationsWriter.OLDwriteLocation
(Geometry geom, Coordinate p, double tolerance) GeometryLocationsWriter.writeComponentLocation
(Geometry geom, Coordinate p, double tolerance) GeometryLocationsWriter.writeFacetLocation
(Geometry geom, Coordinate p, double tolerance) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.ui.render
Fields in org.locationtech.jtstest.testbuilder.ui.render declared as GeometryMethods in org.locationtech.jtstest.testbuilder.ui.render that return GeometryMethods in org.locationtech.jtstest.testbuilder.ui.render with parameters of type GeometryModifier and TypeMethodDescriptionstatic void
GeometryPainter.paint
(Graphics2D g, Viewport viewport, Geometry geometry, Style style) private static void
GeometryPainter.paint
(Geometry geometry, ShapeWriter converter, Graphics2D g, Color lineColor, Color fillColor) private static void
GeometryPainter.paint
(Geometry geometry, ShapeWriter converter, Graphics2D g, Color lineColor, Color fillColor, Stroke stroke) 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) private void
LayerRenderer.render
(Graphics2D g, Viewport viewport, Geometry geometry, Layer layer) private void
LayerRenderer.renderCustomFill
(Graphics2D g, Viewport viewport, Geometry gc, Layer layer) private void
LayerRenderer.renderGeom
(Graphics2D g, Viewport viewport, Geometry geometry, Style style) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.ui.style
Methods in org.locationtech.jtstest.testbuilder.ui.style with parameters of type GeometryModifier and TypeMethodDescriptionvoid
BasicStyle.paint
(Geometry geom, Viewport viewport, Graphics2D g) void
ComponentStyle.paint
(Geometry geom, Viewport viewport, Graphics2D g) void
DataLabelStyle.paint
(Geometry geom, Viewport viewport, Graphics2D g2d) void
LayerStyle.paint
(Geometry geom, Viewport viewport, Graphics2D g) void
LineStringStyle.paint
(Geometry geom, Viewport viewport, Graphics2D g) void
Style.paint
(Geometry geom, Viewport viewport, Graphics2D g) void
StyleList.paint
(Geometry geom, Viewport viewport, Graphics2D g) void
VertexStyle.paint
(Geometry geom, Viewport viewport, Graphics2D g) protected abstract void
ComponentStyle.paintComponent
(Geometry geom, Viewport viewport, Graphics2D graphics) -
Uses of Geometry in org.locationtech.jtstest.testbuilder.ui.tools
Methods in org.locationtech.jtstest.testbuilder.ui.tools that return Geometry -
Uses of Geometry in org.locationtech.jtstest.testrunner
Fields in org.locationtech.jtstest.testrunner declared as GeometryModifier and TypeFieldDescriptionprivate Geometry
TestCase.a
private Geometry
TestCase.b
private Geometry
GeometryResult.geometry
private Geometry
Test.targetGeometry
Methods in org.locationtech.jtstest.testrunner that return GeometryModifier and TypeMethodDescriptionGeometryResult.getGeometry()
TestCase.getGeometryA()
TestCase.getGeometryB()
private Geometry
TestReader.readGeometry
(org.jdom2.Element geometryElement, File wktFile) Methods in org.locationtech.jtstest.testrunner with parameters of type GeometryModifier and TypeMethodDescriptionboolean
BufferResultMatcher.isBoundaryHausdorffDistanceInTolerance
(Geometry actualBuffer, Geometry expectedBuffer, double distance) boolean
BufferResultMatcher.isBufferResultMatch
(Geometry actualBuffer, Geometry expectedBuffer, double distance) 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
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
NullResultMatcher.isMatch
(Geometry geom, String opName, Object[] args, Result actualResult, Result expectedResult, double tolerance) Always reports a match.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.isSymDiffAreaInTolerance
(Geometry actualBuffer, Geometry expectedBuffer) void
TestCase.setGeometryA
(Geometry a) void
TestCase.setGeometryB
(Geometry b) private String
Constructors in org.locationtech.jtstest.testrunner with parameters of type Geometry -
Uses of Geometry in org.locationtech.jtstest.util
Methods in org.locationtech.jtstest.util with parameters of type GeometryModifier and TypeMethodDescriptionstatic void
GeometryDataUtil.setComponentDataToIndex
(Geometry geom) -
Uses of Geometry in org.locationtech.jtstest.util.io
Methods in org.locationtech.jtstest.util.io that return GeometryModifier and TypeMethodDescriptionprivate Geometry
GeoJsonMultiReader.readFeatureCollection
(String s) Extracts all Geometry object substrings and reads themstatic Geometry
IOUtil.readFile
(String filename, GeometryFactory geomFact) private Geometry
MultiFormatReader.readGeoJSON
(String str) private static Geometry
IOUtil.readGeoJSONFile
(String filename, GeometryFactory geomFact) static Geometry
IOUtil.readGeoJSONString
(String s, GeometryFactory geomFact) private Geometry
GeoJsonMultiReader.readGeometry
(String s) private Geometry
private static Geometry
IOUtil.readGMLFile
(String filename, GeometryFactory geomFact) static Geometry
IOUtil.readGMLString
(String gml, GeometryFactory geomFact) private static Geometry
IOUtil.readShapefile
(String filename, GeometryFactory geomFact) private static Geometry
IOUtil.readWKBHexFile
(String filename, GeometryFactory geomFact) static Geometry
IOUtil.readWKBHexString
(String wkb, GeometryFactory geomFact) private static Geometry
IOUtil.readWKTFile
(String filename, GeometryFactory geomFact) static Geometry
IOUtil.readWKTString
(String wkt, GeometryFactory geomFact) Reads one or more WKT geometries from a string.Methods in org.locationtech.jtstest.util.io with parameters of type GeometryModifier and TypeMethodDescriptionprivate void
SVGWriter.appendGeometryTaggedText
(Geometry geometry, int level, Writer writer) Converts aGeometry
to <Geometry Tagged Text> format, then appends it to the writer.Converts aGeometry
to its Well-known Text representation.void
Converts aGeometry
to its Well-known Text representation.SVGWriter.writeFormatted
(Geometry geometry) Same aswrite
, but with newlines and spaces to make the well-known text more readable.private void
SVGWriter.writeFormatted
(Geometry geometry, boolean useFormatting, Writer writer) Converts aGeometry
to its Well-known Text representation.void
SVGWriter.writeFormatted
(Geometry geometry, Writer writer) Same aswrite
, but with newlines and spaces to make the well-known text more readable.