Uses of Class
org.locationtech.jts.geom.Geometry
-
Packages that use Geometry Package Description org.locationtech.jts.algorithm Contains classes and interfaces implementing fundamental computational geometry algorithms.org.locationtech.jts.algorithm.axis org.locationtech.jts.algorithm.construct Provides classes that implement various kinds of geometric constructions.org.locationtech.jts.algorithm.distance Classes to compute distance metrics between geometries.org.locationtech.jts.algorithm.hull Contains classes implementing algorithms to compute hulls of geometry objects.org.locationtech.jts.algorithm.locate Classes to determine the topological location of points in geometries.org.locationtech.jts.algorithm.match Classes to compute matching metrics between geometries.org.locationtech.jts.awt Classes to perform conversions from Java2D shape objects.org.locationtech.jts.coverage Classes that operate on polygonal coverages.org.locationtech.jts.densify Classes to perform densification on geometries.org.locationtech.jts.dissolve org.locationtech.jts.edgegraph org.locationtech.jts.geom Contains theGeometry
interface hierarchy and supporting classes.org.locationtech.jts.geom.prep Classes to perform optimized geometric operations on suitably prepared geometries.org.locationtech.jts.geom.util Provides classes that parse and modify Geometry objects.org.locationtech.jts.geomgraph Contains classes that implement topology graphs.org.locationtech.jts.io Contains the interfaces for converting JTS objects to and from other formats.org.locationtech.jts.io.geojson org.locationtech.jts.io.gml2 Classes to read and write the GML2 geometry format.org.locationtech.jts.io.kml org.locationtech.jts.io.twkb org.locationtech.jts.linearref Contains classes and interfaces implementing linear referencing on linear geometriesorg.locationtech.jts.noding Classes to compute nodings for arrangements of line segments and line segment sequences.org.locationtech.jts.operation Provides classes for implementing operations on geometriesorg.locationtech.jts.operation.buffer Provides classes for computing buffers of geometriesorg.locationtech.jts.operation.buffer.validate Classes to perform validation of the results of buffer operations.org.locationtech.jts.operation.distance Provides classes for computing the distance between geometriesorg.locationtech.jts.operation.distance3d org.locationtech.jts.operation.linemerge Classes to perform line merging.org.locationtech.jts.operation.overlay Contains classes that perform a topological overlay to compute boolean spatial functions.org.locationtech.jts.operation.overlay.snap Classes to perform snapping on geometries to prepare them for overlay operations.org.locationtech.jts.operation.overlay.validate Classes to validate the results of overlay operations.org.locationtech.jts.operation.overlayarea org.locationtech.jts.operation.overlayng Contains classes that perform vector overlay to compute boolean set-theoretic spatial functions.org.locationtech.jts.operation.polygonize An API for polygonizing sets of lines.org.locationtech.jts.operation.predicate Classes which implement topological predicates optimized for particular kinds of geometries.org.locationtech.jts.operation.relate Contains classes to implement the computation of the spatial relationships ofGeometry
s.org.locationtech.jts.operation.relateng Provides classes to implement the RelateNG algorithm computes topological relationships ofGeometry
s.org.locationtech.jts.operation.union Classes to perform efficient unioning of collections of geometries.org.locationtech.jts.operation.valid Classes for testing the validity and simplicity of geometries, as defined in the OGC Simple Features specification.org.locationtech.jts.precision Provides classes for analyzing and manipulating the precision of Geometries.org.locationtech.jts.shape org.locationtech.jts.shape.fractal org.locationtech.jts.shape.random org.locationtech.jts.simplify Classes which implement algorithms for simplifying or generalizing geometries.org.locationtech.jts.triangulate Classes to compute Delaunay triangulations.org.locationtech.jts.triangulate.polygon Classes for triangulating polygons.org.locationtech.jts.triangulate.quadedge Classes to implement a topological subdivision of quadeges, to support creating triangulations and Voronoi diagrams.org.locationtech.jts.triangulate.tri Classes for representing a planar triangulation as a set of linked triangles.org.locationtech.jts.util Contains support classes for the Java Topology Suite.org.locationtech.jtsexample.technique org.locationtech.jtslab org.locationtech.jtslab.clean org.locationtech.jtslab.clip org.locationtech.jtslab.edgeray org.locationtech.jtslab.geom.util org.locationtech.jtstest.clean org.locationtech.jtstest.cmd org.locationtech.jtstest.function org.locationtech.jtstest.geomfunction org.locationtech.jtstest.geomop org.locationtech.jtstest.test org.locationtech.jtstest.testbuilder org.locationtech.jtstest.testbuilder.controller org.locationtech.jtstest.testbuilder.geom org.locationtech.jtstest.testbuilder.io org.locationtech.jtstest.testbuilder.io.shapefile org.locationtech.jtstest.testbuilder.model org.locationtech.jtstest.testbuilder.topostretch org.locationtech.jtstest.testbuilder.ui org.locationtech.jtstest.testbuilder.ui.render org.locationtech.jtstest.testbuilder.ui.style org.locationtech.jtstest.testbuilder.ui.tools org.locationtech.jtstest.testrunner org.locationtech.jtstest.util org.locationtech.jtstest.util.io -
-
Uses of Geometry in org.locationtech.jts.algorithm
Methods in org.locationtech.jts.algorithm that return Geometry Modifier and Type Method Description Geometry
MinimumBoundingCircle. getCircle()
Gets a geometry which represents the Minimum Bounding Circle.Geometry
ConvexHull. getConvexHull()
Returns aGeometry
that represents the convex hull of the input geometry.Geometry
MinimumBoundingCircle. getDiameter()
Gets a geometry representing the diameter of the computed Minimum Bounding Circle.Geometry
MinimumBoundingCircle. getFarthestPoints()
Deprecated.use #getMaximumDiameter()Geometry
MinimumBoundingCircle. getMaximumDiameter()
Gets a geometry representing the maximum diameter of the input.static Geometry
MinimumDiameter. getMinimumDiameter(Geometry geom)
Gets the length of the minimum diameter enclosing a geometrystatic Geometry
MinimumAreaRectangle. getMinimumRectangle(Geometry geom)
Gets the minimum-area rectangularPolygon
which encloses the input geometry.Geometry
MinimumDiameter. getMinimumRectangle()
Gets the rectangularPolygon
which encloses the input geometry and is based on the minimum diameter supporting segment.static Geometry
MinimumDiameter. getMinimumRectangle(Geometry geom)
Gets the minimum-width rectangularPolygon
which encloses the input geometry and is based along the supporting segment.Methods in org.locationtech.jts.algorithm with parameters of type Geometry Modifier and Type Method Description static Coordinate
Centroid. getCentroid(Geometry geom)
Computes the centroid point of a geometry.static Coordinate
InteriorPoint. getInteriorPoint(Geometry geom)
Computes a location of an interior point in aGeometry
.static Coordinate
InteriorPointArea. getInteriorPoint(Geometry geom)
Computes an interior point for the polygonal components of a Geometry.static Coordinate
InteriorPointLine. getInteriorPoint(Geometry geom)
Computes an interior point for the linear components of a Geometry.static Coordinate
InteriorPointPoint. getInteriorPoint(Geometry geom)
Computes an interior point for the puntal components of a Geometry.static Geometry
MinimumDiameter. getMinimumDiameter(Geometry geom)
Gets the length of the minimum diameter enclosing a geometrystatic Geometry
MinimumAreaRectangle. getMinimumRectangle(Geometry geom)
Gets the minimum-area rectangularPolygon
which encloses the input geometry.static Geometry
MinimumDiameter. getMinimumRectangle(Geometry geom)
Gets the minimum-width rectangularPolygon
which encloses the input geometry and is based along the supporting segment.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.Constructors in org.locationtech.jts.algorithm with parameters of type Geometry Constructor Description Centroid(Geometry geom)
Creates a new instance for computing the centroid of a geometryConvexHull(Geometry geometry)
Create a new convex hull construction for the inputGeometry
.InteriorPointArea(Geometry g)
Creates a new interior point finder for an areal geometry.InteriorPointLine(Geometry g)
InteriorPointPoint(Geometry g)
MinimumAreaRectangle(Geometry inputGeom)
Compute a minimum-area rectangle for a givenGeometry
.MinimumAreaRectangle(Geometry inputGeom, boolean isConvex)
Compute a minimum rectangle for aGeometry
, with a hint if the geometry is convex (e.g. a convex Polygon or LinearRing, or a two-point LineString, or a Point).MinimumBoundingCircle(Geometry geom)
Creates a new object for computing the minimum bounding circle for the point set defined by the vertices of the given geometry.MinimumDiameter(Geometry inputGeom)
Compute a minimum diameter for a givenGeometry
.MinimumDiameter(Geometry inputGeom, boolean isConvex)
Compute a minimum diameter for a giverGeometry
, with a hint if the Geometry is convex (e.g. a convex Polygon or LinearRing, or a two-point LineString, or a Point). -
Uses of Geometry in org.locationtech.jts.algorithm.axis
Methods in org.locationtech.jts.algorithm.axis that return Geometry Modifier and Type Method Description static Geometry
ApproximateMedialAxis. medialAxis(Geometry geom)
Methods in org.locationtech.jts.algorithm.axis with parameters of type Geometry Modifier and Type Method Description static Geometry
ApproximateMedialAxis. medialAxis(Geometry geom)
-
Uses of Geometry in org.locationtech.jts.algorithm.construct
Methods in org.locationtech.jts.algorithm.construct with parameters of type Geometry Modifier and Type Method Description static Point
LargestEmptyCircle. getCenter(Geometry obstacles, double tolerance)
Computes the center point of the Largest Empty Circle interior-disjoint to a set of obstacles, with accuracy to a given tolerance distance.static Point
LargestEmptyCircle. getCenter(Geometry obstacles, Geometry boundary, double tolerance)
Computes the center point of the Largest Empty Circle interior-disjoint to a set of obstacles and within a polygonal boundary, with accuracy to a given tolerance distance.static Point
MaximumInscribedCircle. getCenter(Geometry polygonal, double tolerance)
Computes the center point of the Maximum Inscribed Circle of a polygonal geometry, up to a given tolerance distance.static LineString
LargestEmptyCircle. getRadiusLine(Geometry obstacles, double tolerance)
Computes a radius line of the Largest Empty Circle interior-disjoint to a set of obstacles, with accuracy to a given tolerance distance.static LineString
LargestEmptyCircle. getRadiusLine(Geometry obstacles, Geometry boundary, double tolerance)
Computes a radius line of the Largest Empty Circle interior-disjoint to a set of obstacles and within a polygonal boundary, with accuracy to a given tolerance distance.static LineString
MaximumInscribedCircle. getRadiusLine(Geometry polygonal, double tolerance)
Computes a radius line of the Maximum Inscribed Circle of a polygonal geometry, up to a given tolerance distance.Constructors in org.locationtech.jts.algorithm.construct with parameters of type Geometry Constructor Description LargestEmptyCircle(Geometry obstacles, Geometry boundary, double tolerance)
Creates a new instance of a Largest Empty Circle construction, interior-disjoint to a set of obstacle geometries and having its center within a polygonal boundary.MaximumInscribedCircle(Geometry polygonal, double tolerance)
Creates a new instance of a Maximum Inscribed Circle computation. -
Uses of Geometry in org.locationtech.jts.algorithm.distance
Methods in org.locationtech.jts.algorithm.distance with parameters of type Geometry Modifier and Type Method Description static void
DistanceToPoint. computeDistance(Geometry geom, Coordinate pt, PointPairDistance ptDist)
static double
DiscreteFrechetDistance. distance(Geometry g0, Geometry g1)
Computes the Discrete Fréchet Distance between twoGeometry
s using aCartesian
distance computation function.static double
DiscreteHausdorffDistance. distance(Geometry g0, Geometry g1)
static double
DiscreteHausdorffDistance. distance(Geometry g0, Geometry g1, double densifyFrac)
Constructors in org.locationtech.jts.algorithm.distance with parameters of type Geometry Constructor Description DiscreteFrechetDistance(Geometry g0, Geometry g1)
Creates an instance of this class using the provided geometries.DiscreteHausdorffDistance(Geometry g0, Geometry g1)
MaxDensifiedByFractionDistanceFilter(Geometry geom, double fraction)
MaxPointDistanceFilter(Geometry geom)
-
Uses of Geometry in org.locationtech.jts.algorithm.hull
Methods in org.locationtech.jts.algorithm.hull that return Geometry Modifier and Type Method Description static Geometry
ConcaveHull. alphaShape(Geometry geom, double alpha, boolean isHolesAllowed)
Computes the alpha shape of a geometry as a polygon.static Geometry
ConcaveHullOfPolygons. concaveFillByLength(Geometry polygons, double maxLength)
Computes a concave fill area between a set of polygons, using the target criterion of maximum edge length.static Geometry
ConcaveHullOfPolygons. concaveFillByLengthRatio(Geometry polygons, double lengthRatio)
Computes a concave fill area between a set of polygons, using the target criterion of maximum edge length ratio.static Geometry
ConcaveHull. concaveHullByLength(Geometry geom, double maxLength)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length.static Geometry
ConcaveHull. concaveHullByLength(Geometry geom, double maxLength, boolean isHolesAllowed)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length, and optionally allowing holes.static Geometry
ConcaveHullOfPolygons. concaveHullByLength(Geometry polygons, double maxLength)
Computes a concave hull of set of polygons using the target criterion of maximum edge length.static Geometry
ConcaveHullOfPolygons. concaveHullByLength(Geometry polygons, double maxLength, boolean isTight, boolean isHolesAllowed)
Computes a concave hull of set of polygons using the target criterion of maximum edge length, and allowing control over whether the hull boundary is tight and can contain holes.static Geometry
ConcaveHull. concaveHullByLengthRatio(Geometry geom, double lengthRatio)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length ratio.static Geometry
ConcaveHull. concaveHullByLengthRatio(Geometry geom, double lengthRatio, boolean isHolesAllowed)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length factor, and optionally allowing holes.static Geometry
ConcaveHullOfPolygons. concaveHullByLengthRatio(Geometry polygons, double lengthRatio)
Computes a concave hull of set of polygons using the target criterion of maximum edge length ratio.static Geometry
ConcaveHullOfPolygons. concaveHullByLengthRatio(Geometry polygons, double lengthRatio, boolean isTight, boolean isHolesAllowed)
Computes a concave hull of set of polygons using the target criterion of maximum edge length ratio, and allowing control over whether the hull boundary is tight and can contain holes.Geometry
ConcaveHullOfPolygons. getFill()
Gets the concave fill, which is the area between the input polygons, subject to the concaveness control parameter.Geometry
ConcaveHull. getHull()
Gets the computed concave hull.Geometry
ConcaveHullOfPolygons. getHull()
Gets the computed concave hull.Methods in org.locationtech.jts.algorithm.hull with parameters of type Geometry Modifier and Type Method Description static Geometry
ConcaveHull. alphaShape(Geometry geom, double alpha, boolean isHolesAllowed)
Computes the alpha shape of a geometry as a polygon.static Geometry
ConcaveHullOfPolygons. concaveFillByLength(Geometry polygons, double maxLength)
Computes a concave fill area between a set of polygons, using the target criterion of maximum edge length.static Geometry
ConcaveHullOfPolygons. concaveFillByLengthRatio(Geometry polygons, double lengthRatio)
Computes a concave fill area between a set of polygons, using the target criterion of maximum edge length ratio.static Geometry
ConcaveHull. concaveHullByLength(Geometry geom, double maxLength)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length.static Geometry
ConcaveHull. concaveHullByLength(Geometry geom, double maxLength, boolean isHolesAllowed)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length, and optionally allowing holes.static Geometry
ConcaveHullOfPolygons. concaveHullByLength(Geometry polygons, double maxLength)
Computes a concave hull of set of polygons using the target criterion of maximum edge length.static Geometry
ConcaveHullOfPolygons. concaveHullByLength(Geometry polygons, double maxLength, boolean isTight, boolean isHolesAllowed)
Computes a concave hull of set of polygons using the target criterion of maximum edge length, and allowing control over whether the hull boundary is tight and can contain holes.static Geometry
ConcaveHull. concaveHullByLengthRatio(Geometry geom, double lengthRatio)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length ratio.static Geometry
ConcaveHull. concaveHullByLengthRatio(Geometry geom, double lengthRatio, boolean isHolesAllowed)
Computes a concave hull of the vertices in a geometry using the target criterion of maximum edge length factor, and optionally allowing holes.static Geometry
ConcaveHullOfPolygons. concaveHullByLengthRatio(Geometry polygons, double lengthRatio)
Computes a concave hull of set of polygons using the target criterion of maximum edge length ratio.static Geometry
ConcaveHullOfPolygons. concaveHullByLengthRatio(Geometry polygons, double lengthRatio, boolean isTight, boolean isHolesAllowed)
Computes a concave hull of set of polygons using the target criterion of maximum edge length ratio, and allowing control over whether the hull boundary is tight and can contain holes.static double
ConcaveHull. uniformGridEdgeLength(Geometry geom)
Computes the approximate edge length of a uniform square grid having the same number of points as a geometry and the same area as its convex hull.Constructors in org.locationtech.jts.algorithm.hull with parameters of type Geometry Constructor Description ConcaveHull(Geometry geom)
Creates a new instance for a given geometry.ConcaveHullOfPolygons(Geometry polygons)
Creates a new instance for a given geometry. -
Uses of Geometry in org.locationtech.jts.algorithm.locate
Methods in org.locationtech.jts.algorithm.locate with parameters of type Geometry Modifier and Type Method Description static boolean
SimplePointInAreaLocator. isContained(Coordinate p, Geometry geom)
Determines whether a point is contained in aGeometry
, or lies on its boundary.static int
SimplePointInAreaLocator. locate(Coordinate p, Geometry geom)
Constructors in org.locationtech.jts.algorithm.locate with parameters of type Geometry Constructor Description IndexedPointInAreaLocator(Geometry g)
Creates a new locator for a givenGeometry
.SimplePointInAreaLocator(Geometry geom)
Create an instance of a point-in-area locator, using the provided areal geometry. -
Uses of Geometry in org.locationtech.jts.algorithm.match
Methods in org.locationtech.jts.algorithm.match with parameters of type Geometry Modifier and Type Method Description double
AreaSimilarityMeasure. measure(Geometry g1, Geometry g2)
double
FrechetSimilarityMeasure. measure(Geometry g1, Geometry g2)
double
HausdorffSimilarityMeasure. measure(Geometry g1, Geometry g2)
double
SimilarityMeasure. measure(Geometry g1, Geometry g2)
Computes the similarity measure between two geometries -
Uses of Geometry in org.locationtech.jts.awt
Methods in org.locationtech.jts.awt that return Geometry Modifier and Type Method Description static Geometry
FontGlyphReader. read(String text, Font font, double flatness, GeometryFactory geomFact)
static Geometry
FontGlyphReader. read(String text, Font font, GeometryFactory geomFact)
static Geometry
FontGlyphReader. read(String text, String fontName, int pointSize, GeometryFactory geomFact)
Converts text rendered in the given font and pointsize to aGeometry
using a standard flatness factor.Geometry
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 Modifier and Type Method Description Shape
ShapeWriter. toShape(Geometry geometry)
-
Uses of Geometry in org.locationtech.jts.coverage
Methods in org.locationtech.jts.coverage that return Geometry Modifier and Type Method Description Geometry
CoverageGapFinder. findGaps(double gapWidth)
Finds gaps in the coverage.static Geometry
CoverageGapFinder. findGaps(Geometry[] coverage, double gapWidth)
Finds gaps in a polygonal coverage.Geometry[]
CoverageSimplifier. simplify(double tolerance)
Computes the simplified coverage using a single distance tolerance, preserving the coverage topology.Geometry[]
CoverageSimplifier. simplify(double[] tolerances)
Computes the simplified coverage using separate distance tolerances for each coverage element, preserving the coverage topology.Geometry[]
CoverageSimplifier. simplify(double toleranceInner, double toleranceOuter)
Computes the simplified coverage using separate distance tolerances for inner and outer edges, preserving the coverage topology.static Geometry[]
CoverageSimplifier. simplify(Geometry[] coverage, double tolerance)
Simplifies the boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology.static Geometry[]
CoverageSimplifier. simplify(Geometry[] coverage, double[] tolerances)
Simplifies the boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology, using a separate tolerance for each element of the coverage.static Geometry[]
CoverageSimplifier. simplifyInner(Geometry[] coverage, double tolerance)
Simplifies the inner boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology.static Geometry[]
CoverageSimplifier. simplifyOuter(Geometry[] coverage, double tolerance)
Simplifies the outer boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology.static Geometry
CoverageUnion. union(Geometry[] coverage)
Unions a polygonal coverage.Geometry
CoveragePolygonValidator. validate()
Validates the coverage polygon against the set of adjacent polygons in the coverage.static Geometry
CoveragePolygonValidator. validate(Geometry targetPolygon, Geometry[] adjPolygons)
Validates that a polygon is coverage-valid against the surrounding polygons in a polygonal coverage.static Geometry
CoveragePolygonValidator. validate(Geometry targetPolygon, Geometry[] adjPolygons, double gapWidth)
Validates that a polygon is coverage-valid against the surrounding polygons in a polygonal coverage, and forms no gaps narrower than a specified width.Geometry[]
CoverageValidator. validate()
Validates the polygonal coverage.static Geometry[]
CoverageValidator. validate(Geometry[] coverage)
Validates that a set of polygons forms a valid polygonal coverage, and returns linear geometries indicating the locations of invalidities, if any.static Geometry[]
CoverageValidator. validate(Geometry[] coverage, double gapWidth)
Validates that a set of polygons forms a valid polygonal coverage and contains no gaps narrower than a specified width.Methods in org.locationtech.jts.coverage with parameters of type Geometry Modifier and Type Method Description static Geometry
CoverageGapFinder. findGaps(Geometry[] coverage, double gapWidth)
Finds gaps in a polygonal coverage.static boolean
CoverageValidator. hasInvalidResult(Geometry[] validateResult)
Tests if some element of an array of geometries is a coverage invalidity indicator.static boolean
CoverageValidator. isValid(Geometry[] coverage)
Tests whether a polygonal coverage is valid.static Geometry[]
CoverageSimplifier. simplify(Geometry[] coverage, double tolerance)
Simplifies the boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology.static Geometry[]
CoverageSimplifier. simplify(Geometry[] coverage, double[] tolerances)
Simplifies the boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology, using a separate tolerance for each element of the coverage.static Geometry[]
CoverageSimplifier. simplifyInner(Geometry[] coverage, double tolerance)
Simplifies the inner boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology.static Geometry[]
CoverageSimplifier. simplifyOuter(Geometry[] coverage, double tolerance)
Simplifies the outer boundaries of a set of polygonal geometries forming a coverage, preserving the coverage topology.static Geometry
CoverageUnion. union(Geometry[] coverage)
Unions a polygonal coverage.static Geometry
CoveragePolygonValidator. validate(Geometry targetPolygon, Geometry[] adjPolygons)
Validates that a polygon is coverage-valid against the surrounding polygons in a polygonal coverage.static Geometry
CoveragePolygonValidator. validate(Geometry targetPolygon, Geometry[] adjPolygons, double gapWidth)
Validates that a polygon is coverage-valid against the surrounding polygons in a polygonal coverage, and forms no gaps narrower than a specified width.static Geometry[]
CoverageValidator. validate(Geometry[] coverage)
Validates that a set of polygons forms a valid polygonal coverage, and returns linear geometries indicating the locations of invalidities, if any.static Geometry[]
CoverageValidator. validate(Geometry[] coverage, double gapWidth)
Validates that a set of polygons forms a valid polygonal coverage and contains no gaps narrower than a specified width.Constructors in org.locationtech.jts.coverage with parameters of type Geometry Constructor Description CoverageGapFinder(Geometry[] coverage)
Creates a new polygonal coverage gap finder.CoveragePolygonValidator(Geometry geom, Geometry[] adjGeoms)
Create a new validator.CoverageSimplifier(Geometry[] coverage)
Create a new coverage simplifier instance.CoverageValidator(Geometry[] coverage)
Creates a new coverage validator -
Uses of Geometry in org.locationtech.jts.densify
Methods in org.locationtech.jts.densify that return Geometry Modifier and Type Method Description static Geometry
Densifier. densify(Geometry geom, double distanceTolerance)
Densifies a geometry using a given distance tolerance, and respecting the input geometry'sPrecisionModel
.Geometry
Densifier. getResultGeometry()
Gets the densified geometry.Methods in org.locationtech.jts.densify with parameters of type Geometry Modifier and Type Method Description static Geometry
Densifier. densify(Geometry geom, double distanceTolerance)
Densifies a geometry using a given distance tolerance, and respecting the input geometry'sPrecisionModel
.Constructors in org.locationtech.jts.densify with parameters of type Geometry Constructor Description Densifier(Geometry inputGeom)
Creates a new densifier instance. -
Uses of Geometry in org.locationtech.jts.dissolve
Methods in org.locationtech.jts.dissolve that return Geometry Modifier and Type Method Description static Geometry
LineDissolver. dissolve(Geometry g)
Dissolves the linear components in a geometry.Geometry
LineDissolver. getResult()
Gets the dissolved result as a MultiLineString.Methods in org.locationtech.jts.dissolve with parameters of type Geometry Modifier and Type Method Description void
LineDissolver. add(Geometry geometry)
Adds aGeometry
to be dissolved.static Geometry
LineDissolver. dissolve(Geometry g)
Dissolves the linear components in a geometry. -
Uses of Geometry in org.locationtech.jts.edgegraph
Methods in org.locationtech.jts.edgegraph with parameters of type Geometry Modifier and Type Method Description void
EdgeGraphBuilder. add(Geometry geometry)
Adds the edges of a Geometry to the graph. -
Uses of Geometry in org.locationtech.jts.geom
Subclasses of Geometry in org.locationtech.jts.geom Modifier and Type Class Description class
GeometryCollection
Models a collection ofGeometry
s of arbitrary type and dimension.class
LinearRing
Models an OGC SFSLinearRing
.class
LineString
Models an OGC-styleLineString
.class
MultiLineString
Models a collection ofLineString
s.class
MultiPoint
Models a collection ofPoint
s.class
MultiPolygon
Models a collection ofPolygon
s.class
Point
Represents a single point.class
Polygon
Represents a polygon with linear edges, which may include holes.Fields in org.locationtech.jts.geom declared as Geometry Modifier and Type Field Description protected Geometry[]
GeometryCollection. geometries
Internal representation of thisGeometryCollection
.Methods in org.locationtech.jts.geom that return Geometry Modifier and Type Method Description Geometry
Geometry. buffer(double distance)
Computes a buffer area around this geometry having the given width.Geometry
Geometry. buffer(double distance, int quadrantSegments)
Computes a buffer area around this geometry having the given width and with a specified accuracy of approximation for circular arcs.Geometry
Geometry. buffer(double distance, int quadrantSegments, int endCapStyle)
Computes a buffer area around this geometry having the given width and with a specified accuracy of approximation for circular arcs, and using a specified end cap style.Geometry
GeometryFactory. buildGeometry(Collection geomList)
Build an appropriateGeometry
,MultiGeometry
, orGeometryCollection
to contain theGeometry
s in it.Geometry
Geometry. convexHull()
Computes the smallest convexPolygon
that contains all the points in theGeometry
.Geometry
Polygon. convexHull()
Geometry
Geometry. copy()
Creates a deep copy of thisGeometry
object.protected abstract Geometry
Geometry. copyInternal()
An internal method to copy subclass-specific geometry data.Geometry
GeometryFactory. createEmpty(int dimension)
Creates an empty atomic geometry of the given dimension.Geometry
GeometryFactory. createGeometry(Geometry g)
Creates a deep copy of the inputGeometry
.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.abstract Geometry
Geometry. getBoundary()
Returns the boundary, or an empty geometry of appropriate dimension if thisGeometry
is empty.Geometry
GeometryCollection. getBoundary()
Geometry
LineString. getBoundary()
Gets the boundary of this geometry.Geometry
MultiLineString. getBoundary()
Gets the boundary of this geometry.Geometry
MultiPoint. getBoundary()
Gets the boundary of this geometry.Geometry
MultiPolygon. getBoundary()
Computes the boundary of this geometryGeometry
Point. getBoundary()
Gets the boundary of this geometry.Geometry
Polygon. getBoundary()
Computes the boundary of this geometryGeometry
Geometry. getEnvelope()
Gets a Geometry representing the envelope (bounding box) of thisGeometry
.Geometry
Geometry. getGeometryN(int n)
Returns an elementGeometry
from aGeometryCollection
(orthis
, if the geometry is not a collection).Geometry
GeometryCollection. getGeometryN(int n)
Geometry
Geometry. intersection(Geometry other)
Computes aGeometry
representing the point-set which is common to both thisGeometry
and theother
Geometry.Geometry
Geometry. norm()
Creates a new Geometry which is a normalized copy of this Geometry.static Geometry
OctagonalEnvelope. octagonalEnvelope(Geometry geom)
Gets the octagonal envelope of a geometryGeometry
Geometry. reverse()
Computes a new geometry which has all component coordinate sequences in reverse order (opposite orientation) to this one.protected abstract Geometry
Geometry. reverseInternal()
Geometry
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
.Geometry
GeometryFactory. toGeometry(Envelope envelope)
Creates aGeometry
with the same extent as the given envelope.Geometry
OctagonalEnvelope. toGeometry(GeometryFactory geomFactory)
static Geometry[]
GeometryFactory. toGeometryArray(Collection geometries)
Converts theList
to an array.Geometry
Geometry. union()
Computes the union of all the elements of this geometry.Geometry
Geometry. union(Geometry other)
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 Geometry Modifier and Type Method Description boolean
Geometry. contains(Geometry g)
Tests whether this geometry contains the argument geometry.boolean
Geometry. coveredBy(Geometry g)
Tests whether this geometry is covered by the argument geometry.boolean
Geometry. covers(Geometry g)
Tests whether this geometry covers the argument geometry.Geometry
GeometryFactory. createGeometry(Geometry g)
Creates a deep copy of the inputGeometry
.GeometryCollection
GeometryFactory. createGeometryCollection(Geometry[] geometries)
Creates a GeometryCollection using the given Geometries; a null or empty array will create an empty GeometryCollection.static Point
GeometryFactory. createPointFromInternalCoord(Coordinate coord, Geometry exemplar)
boolean
Geometry. crosses(Geometry g)
Tests whether this geometry crosses the argument geometry.Geometry
Geometry. difference(Geometry other)
Computes aGeometry
representing the closure of the point-set of the points contained in thisGeometry
that are not contained in theother
Geometry.boolean
Geometry. disjoint(Geometry g)
Tests whether this geometry is disjoint from the argument geometry.double
Geometry. distance(Geometry g)
Returns the minimum distance between thisGeometry
and anotherGeometry
.boolean
Geometry. equals(Geometry g)
Tests whether this geometry is topologically equal to the argument geometry.boolean
Geometry. equalsExact(Geometry other)
Returns true if the 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
GeometryComponentFilter. filter(Geometry geom)
Performs an operation with or on a geometry component.void
GeometryFilter. filter(Geometry geom)
Performs an operation with or ongeom
.protected static boolean
Geometry. hasNonEmptyElements(Geometry[] geometries)
Returns true if the array contains any non-emptyGeometry
s.Geometry
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.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
Geometry. overlaps(Geometry g)
Tests whether this geometry overlaps the specified geometry.IntersectionMatrix
Geometry. relate(Geometry g)
Returns the DE-9IMIntersectionMatrix
for the twoGeometry
s.boolean
Geometry. relate(Geometry g, String intersectionPattern)
Tests whether the elements in the DE-9IMIntersectionMatrix
for the twoGeometry
s match the elements inintersectionPattern
.Geometry
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
Geometry. touches(Geometry g)
Tests whether this geometry touches the argument geometry.Geometry
Geometry. union(Geometry other)
Computes aGeometry
representing the point-set which is contained in both thisGeometry
and theother
Geometry.boolean
Geometry. within(Geometry g)
Tests whether this geometry is within the specified geometry.Constructors in org.locationtech.jts.geom with parameters of type Geometry Constructor Description GeometryCollection(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
Methods in org.locationtech.jts.geom.prep that return Geometry Modifier and Type Method Description Geometry
PreparedGeometry. getGeometry()
Gets the originalGeometry
which has been prepared.Methods in org.locationtech.jts.geom.prep with parameters of type Geometry Modifier and Type Method Description boolean
PreparedGeometry. contains(Geometry geom)
Tests whether the baseGeometry
contains a given geometry.boolean
PreparedPolygon. contains(Geometry g)
boolean
PreparedGeometry. containsProperly(Geometry geom)
Tests whether the baseGeometry
properly contains a given geometry.boolean
PreparedPolygon. containsProperly(Geometry g)
boolean
PreparedGeometry. coveredBy(Geometry geom)
Tests whether the baseGeometry
is covered by a given geometry.boolean
PreparedGeometry. covers(Geometry geom)
Tests whether the baseGeometry
covers a given geometry.boolean
PreparedPolygon. covers(Geometry g)
PreparedGeometry
PreparedGeometryFactory. create(Geometry geom)
Creates a newPreparedGeometry
appropriate for the argumentGeometry
.boolean
PreparedGeometry. crosses(Geometry geom)
Tests whether the baseGeometry
crosses a given geometry.boolean
PreparedGeometry. disjoint(Geometry geom)
Tests whether the baseGeometry
is disjoint from a given geometry.boolean
PreparedGeometry. intersects(Geometry geom)
Tests whether the baseGeometry
intersects a given geometry.boolean
PreparedLineString. intersects(Geometry g)
boolean
PreparedPoint. intersects(Geometry g)
Tests whether this point intersects aGeometry
.boolean
PreparedPolygon. intersects(Geometry g)
boolean
PreparedGeometry. overlaps(Geometry geom)
Tests whether the baseGeometry
overlaps a given geometry.static PreparedGeometry
PreparedGeometryFactory. prepare(Geometry geom)
Creates a newPreparedGeometry
appropriate for the argumentGeometry
.boolean
PreparedGeometry. touches(Geometry geom)
Tests whether the baseGeometry
touches a given geometry.boolean
PreparedGeometry. within(Geometry geom)
Tests whether the baseGeometry
is within a given geometry. -
Uses of Geometry in org.locationtech.jts.geom.util
Methods in org.locationtech.jts.geom.util that return Geometry Modifier and Type Method Description Geometry
GeometryCombiner. 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
GeometryCombiner. combine(Geometry g0, Geometry g1)
Combines two geometries.static Geometry
GeometryCombiner. combine(Geometry g0, Geometry g1, Geometry g2)
Combines three geometries.static Geometry
SineStarFactory. create(Coordinate origin, double size, int nPts, int nArms, double armLengthRatio)
Creates a sine star with the given parameters.Geometry
SineStarFactory. createSineStar()
Generates the geometry for the sine starGeometry
GeometryEditor.CoordinateOperation. edit(Geometry geometry, GeometryFactory factory)
Geometry
GeometryEditor.CoordinateSequenceOperation. edit(Geometry geometry, GeometryFactory factory)
Geometry
GeometryEditor. edit(Geometry geometry, GeometryEditor.GeometryEditorOperation operation)
Edit the inputGeometry
with the given edit operation.Geometry
GeometryEditor.GeometryEditorOperation. edit(Geometry geometry, GeometryFactory factory)
Edits a Geometry by returning a new Geometry with a modification.Geometry
GeometryEditor.NoOpGeometryOperation. edit(Geometry geometry, GeometryFactory factory)
static Geometry
GeometryFixer. fix(Geometry geom)
Fixes a geometry to be valid.static Geometry
GeometryFixer. fix(Geometry geom, boolean isKeepMulti)
Fixes a geometry to be valid, allowing to set a flag controlling how single item results from fixedMULTI
geometries should be returned.static Geometry
GeometryMapper. flatMap(Geometry geom, int emptyDim, GeometryMapper.MapOp op)
Maps the atomic elements of aGeometry
(which may be atomic or composite) using aGeometryMapper.MapOp
mapping operation into an atomic Geometry or a flat collection of the most specific type.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
.Geometry
GeometryTransformer. getInputGeometry()
Utility function to make input geometry availableGeometry
GeometryFixer. getResult()
Gets the fixed geometry.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.Geometry
GeometryMapper.MapOp. map(Geometry geom)
Maps a geometry value into another value.Geometry
AffineTransformation. transform(Geometry g)
Creates a newGeometry
which is the result of this transformation applied to the input Geometry.Geometry
GeometryTransformer. transform(Geometry inputGeom)
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 that return types with arguments of type Geometry Modifier and Type Method Description static List<Geometry>
PolygonalExtracter. getPolygonals(Geometry geom)
static List<Geometry>
PolygonalExtracter. getPolygonals(Geometry geom, List<Geometry> list)
Methods in org.locationtech.jts.geom.util with parameters of type Geometry Modifier and Type Method Description void
ShortCircuitedGeometryVisitor. applyTo(Geometry geom)
static Geometry
GeometryCombiner. combine(Geometry g0, Geometry g1)
Combines two geometries.static Geometry
GeometryCombiner. combine(Geometry g0, Geometry g1, Geometry g2)
Combines three geometries.abstract Coordinate[]
GeometryEditor.CoordinateOperation. edit(Coordinate[] coordinates, Geometry geometry)
Edits the array ofCoordinate
s from aGeometry
.Geometry
GeometryEditor.CoordinateOperation. edit(Geometry geometry, GeometryFactory factory)
abstract CoordinateSequence
GeometryEditor.CoordinateSequenceOperation. edit(CoordinateSequence coordSeq, Geometry geometry)
Edits aCoordinateSequence
from aGeometry
.Geometry
GeometryEditor.CoordinateSequenceOperation. edit(Geometry geometry, GeometryFactory factory)
Geometry
GeometryEditor. edit(Geometry geometry, GeometryEditor.GeometryEditorOperation operation)
Edit the inputGeometry
with the given edit operation.Geometry
GeometryEditor.GeometryEditorOperation. edit(Geometry geometry, GeometryFactory factory)
Edits a Geometry by returning a new Geometry with a modification.Geometry
GeometryEditor.NoOpGeometryOperation. edit(Geometry geometry, GeometryFactory factory)
static List
GeometryExtracter. extract(Geometry geom, Class clz)
Deprecated.static List
GeometryExtracter. extract(Geometry geom, Class clz, List list)
Deprecated.static List
GeometryExtracter. extract(Geometry geom, String geometryType)
static List
GeometryExtracter. extract(Geometry geom, String geometryType, List list)
void
ComponentCoordinateExtracter. filter(Geometry geom)
void
GeometryExtracter. filter(Geometry geom)
void
LinearComponentExtracter. filter(Geometry geom)
void
LineStringExtracter. filter(Geometry geom)
void
PointExtracter. filter(Geometry geom)
void
PolygonExtracter. filter(Geometry geom)
static Geometry
GeometryFixer. fix(Geometry geom)
Fixes a geometry to be valid.static Geometry
GeometryFixer. fix(Geometry geom, boolean isKeepMulti)
Fixes a geometry to be valid, allowing to set a flag controlling how single item results from fixedMULTI
geometries should be returned.static Geometry
GeometryMapper. flatMap(Geometry geom, int emptyDim, GeometryMapper.MapOp op)
Maps the atomic elements of aGeometry
(which may be atomic or composite) using aGeometryMapper.MapOp
mapping operation into an atomic Geometry or a flat collection of the most specific type.static List
ComponentCoordinateExtracter. getCoordinates(Geometry geom)
Extracts a representativeCoordinate
from each connected component in a 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
LinearComponentExtracter. getLines(Geometry geom)
Extracts the linear components from a single geometry.static List
LinearComponentExtracter. getLines(Geometry geom, boolean forceToLineString)
Extracts the linear components from a single geometry.static Collection
LinearComponentExtracter. getLines(Geometry geom, Collection lines)
Extracts the linear components from a 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
LineStringExtracter. getLines(Geometry geom)
static List
LineStringExtracter. getLines(Geometry geom, List lines)
static List
PointExtracter. getPoints(Geometry geom)
static List
PointExtracter. getPoints(Geometry geom, List list)
static List<Geometry>
PolygonalExtracter. getPolygonals(Geometry geom)
static List<Geometry>
PolygonalExtracter. getPolygonals(Geometry geom, List<Geometry> list)
static List
PolygonExtracter. getPolygons(Geometry geom)
static List
PolygonExtracter. getPolygons(Geometry geom, List list)
protected static boolean
GeometryExtracter. isOfType(Geometry geom, String geometryType)
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.Geometry
GeometryMapper.MapOp. map(Geometry geom)
Maps a geometry value into another value.Geometry
AffineTransformation. transform(Geometry g)
Creates a newGeometry
which is the result of this transformation applied to the input Geometry.Geometry
GeometryTransformer. transform(Geometry inputGeom)
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
ShortCircuitedGeometryVisitor. visit(Geometry element)
Method parameters in org.locationtech.jts.geom.util with type arguments of type Geometry Modifier and Type Method Description static List<Geometry>
PolygonalExtracter. getPolygonals(Geometry geom, List<Geometry> list)
Constructors in org.locationtech.jts.geom.util with parameters of type Geometry Constructor Description GeometryFixer(Geometry geom)
Creates a new instance to fix a given geometry. -
Uses of Geometry in org.locationtech.jts.geomgraph
Methods in org.locationtech.jts.geomgraph that return Geometry Modifier and Type Method Description Geometry
GeometryGraph. getGeometry()
Constructors in org.locationtech.jts.geomgraph with parameters of type Geometry Constructor Description GeometryGraph(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 Geometry Modifier and Type Method Description Geometry
WKBReader. read(byte[] bytes)
Reads a singleGeometry
in WKB format from a byte array.Geometry
WKBReader. read(InStream is)
Geometry
WKTReader. read(Reader reader)
Geometry
WKTReader. read(String wellKnownText)
Methods in org.locationtech.jts.io with parameters of type Geometry Modifier and Type Method Description byte[]
WKBWriter. write(Geometry geom)
Writes aGeometry
into a byte array.void
WKBWriter. write(Geometry geom, OutStream os)
String
WKTWriter. write(Geometry geometry)
Converts aGeometry
to its Well-known Text representation.void
WKTWriter. write(Geometry geometry, Writer writer)
Converts aGeometry
to its Well-known Text representation.String
WKTWriter. writeFormatted(Geometry geometry)
Same aswrite
, but with newlines and spaces to make the well-known text more readable.void
WKTWriter. writeFormatted(Geometry geometry, Writer writer)
Same aswrite
, but with newlines and spaces to make the well-known text more readable. -
Uses of Geometry in org.locationtech.jts.io.geojson
Methods in org.locationtech.jts.io.geojson that return Geometry Modifier and Type Method Description Geometry
GeoJsonReader. read(Reader reader)
Geometry
GeoJsonReader. read(String json)
Reads a GeoJson Geometry from a String into a singleGeometry
.static Geometry
OrientationTransformer. transformCCW(Geometry geometry)
Transforms a geometry using the Right Hand Rule specifications defined in the latest GeoJSON specification.Methods in org.locationtech.jts.io.geojson with parameters of type Geometry Modifier and Type Method Description static Geometry
OrientationTransformer. transformCCW(Geometry geometry)
Transforms a geometry using the Right Hand Rule specifications defined in the latest GeoJSON specification.String
GeoJsonWriter. write(Geometry geometry)
Writes aGeometry
in GeoJson format to a String.void
GeoJsonWriter. write(Geometry geometry, Writer writer)
-
Uses of Geometry in org.locationtech.jts.io.gml2
Methods in org.locationtech.jts.io.gml2 that return Geometry Modifier and Type Method Description Geometry
GMLHandler. getGeometry()
Gets the geometry parsed by this handler.Geometry
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.Geometry
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 Geometry Modifier and Type Method Description String
GMLWriter. write(Geometry geom)
Writes aGeometry
in GML2 format to a String.void
GMLWriter. write(Geometry geom, Writer writer)
-
Uses of Geometry in org.locationtech.jts.io.kml
Methods in org.locationtech.jts.io.kml that return Geometry Modifier and Type Method Description Geometry
KMLReader. read(String kmlGeometryString)
Methods in org.locationtech.jts.io.kml with parameters of type Geometry Modifier and Type Method Description String
KMLWriter. write(Geometry geom)
Writes aGeometry
in KML format as a string.void
KMLWriter. write(Geometry geometry, Writer writer)
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. -
Uses of Geometry in org.locationtech.jts.io.twkb
Methods in org.locationtech.jts.io.twkb that return Geometry Modifier and Type Method Description Geometry
TWKBReader. read(byte[] bytes)
Geometry
TWKBReader. read(DataInput in)
Geometry
TWKBReader. read(InputStream in)
Methods in org.locationtech.jts.io.twkb with parameters of type Geometry Modifier and Type Method Description byte[]
TWKBWriter. write(Geometry geom)
void
TWKBWriter. write(Geometry geom, DataOutput out)
void
TWKBWriter. write(Geometry geom, OutputStream out)
-
Uses of Geometry in org.locationtech.jts.linearref
Methods in org.locationtech.jts.linearref that return Geometry Modifier and Type Method Description Geometry
LengthIndexedLine. extractLine(double startIndex, double endIndex)
Computes theLineString
for the interval on the line between the given indices.Geometry
LocationIndexedLine. extractLine(LinearLocation startIndex, LinearLocation endIndex)
Computes theLineString
for the interval on the line between the given indices.Geometry
LinearGeometryBuilder. getGeometry()
Methods in org.locationtech.jts.linearref with parameters of type Geometry Modifier and Type Method Description void
LinearLocation. clamp(Geometry linear)
Ensures the indexes are valid for a given linearGeometry
.Coordinate
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.LineSegment
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.double[]
LengthIndexedLine. indicesOf(Geometry subLine)
Computes the indices for a subline of the line.LinearLocation[]
LocationIndexedLine. indicesOf(Geometry subLine)
Computes the indices for a subline of the line.boolean
LinearLocation. isEndpoint(Geometry linearGeom)
Tests whether this location is an endpoint of the linear component it refers to.boolean
LinearLocation. isValid(Geometry linearGeom)
Tests whether this location refers to a valid location on the given linearGeometry
.void
LinearLocation. setToEnd(Geometry linear)
Sets the value of this location to refer to the end of a linear geometry.void
LinearLocation. snapToVertex(Geometry linearGeom, double minDistance)
Snaps the value of this location to the nearest vertex on the given linearGeometry
, if the vertex is closer than minDistance.LinearLocation
LinearLocation. toLowest(Geometry linearGeom)
Converts a linear location to the lowest equivalent location index.Constructors in org.locationtech.jts.linearref with parameters of type Geometry Constructor Description LengthIndexedLine(Geometry linearGeom)
Constructs an object which allows a linearGeometry
to be linearly referenced using length as an index.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
. -
Uses of Geometry in org.locationtech.jts.noding
Methods in org.locationtech.jts.noding that return Geometry Modifier and Type Method Description static Geometry
SegmentStringUtil. toGeometry(Collection segStrings, GeometryFactory geomFact)
Converts a collection ofSegmentString
s into aGeometry
.Methods in org.locationtech.jts.noding with parameters of type Geometry Modifier and Type Method Description static List
SegmentStringUtil. extractBasicSegmentStrings(Geometry geom)
Extracts all linear components from a givenGeometry
toBasicSegmentString
s.static List
SegmentStringUtil. extractNodedSegmentStrings(Geometry geom)
Extracts all linear components from a givenGeometry
toNodedSegmentString
s.static List
SegmentStringUtil. extractSegmentStrings(Geometry geom)
Extracts all linear components from a givenGeometry
toSegmentString
s. -
Uses of Geometry in org.locationtech.jts.operation
Methods in org.locationtech.jts.operation that return Geometry Modifier and Type Method Description Geometry
GeometryGraphOperation. getArgGeometry(int i)
Geometry
BoundaryOp. getBoundary()
Gets the computed boundary.static Geometry
BoundaryOp. getBoundary(Geometry g)
Computes a geometry representing the boundary of a geometry.static Geometry
BoundaryOp. getBoundary(Geometry g, BoundaryNodeRule bnRule)
Computes a geometry representing the boundary of a geometry, using an explicitBoundaryNodeRule
.Methods in org.locationtech.jts.operation with parameters of type Geometry Modifier and Type Method Description static Geometry
BoundaryOp. getBoundary(Geometry g)
Computes a geometry representing the boundary of a geometry.static Geometry
BoundaryOp. getBoundary(Geometry g, BoundaryNodeRule bnRule)
Computes a geometry representing the boundary of a geometry, using an explicitBoundaryNodeRule
.static boolean
BoundaryOp. hasBoundary(Geometry geom, BoundaryNodeRule boundaryNodeRule)
Tests if a geometry has a boundary (it is non-empty).Constructors in org.locationtech.jts.operation with parameters of type Geometry Constructor Description BoundaryOp(Geometry geom)
Creates a new instance for the given geometry.BoundaryOp(Geometry geom, BoundaryNodeRule bnRule)
Creates a new instance for the given geometry.GeometryGraphOperation(Geometry g0)
GeometryGraphOperation(Geometry g0, Geometry g1)
GeometryGraphOperation(Geometry g0, Geometry g1, BoundaryNodeRule boundaryNodeRule)
IsSimpleOp(Geometry geom)
Deprecated.Creates a simplicity checker using the default SFS Mod-2 Boundary Node RuleIsSimpleOp(Geometry geom, BoundaryNodeRule boundaryNodeRule)
Deprecated.Creates a simplicity checker using a givenBoundaryNodeRule
-
Uses of Geometry in org.locationtech.jts.operation.buffer
Methods in org.locationtech.jts.operation.buffer that return Geometry Modifier and Type Method Description static Geometry
VariableBuffer. buffer(Geometry line, double[] distance)
Creates a buffer polygon along a line with the distance specified at each vertex.static Geometry
VariableBuffer. buffer(Geometry line, double startDistance, double endDistance)
Creates a buffer polygon along a line with the buffer distance interpolated between a start distance and an end distance.static Geometry
VariableBuffer. buffer(Geometry line, double startDistance, double midDistance, double endDistance)
Creates a buffer polygon along a line with the buffer distance interpolated between a start distance, a middle distance and an end distance.static Geometry
BufferOp. bufferByZero(Geometry geom, boolean isBothOrientations)
Buffers a geometry with distance zero.static Geometry
BufferOp. bufferOp(Geometry g, double distance)
Computes the buffer of a geometry for a given buffer distance.static Geometry
BufferOp. bufferOp(Geometry g, double distance, int quadrantSegments)
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
BufferOp. bufferOp(Geometry g, double distance, int quadrantSegments, int endCapStyle)
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.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.Geometry
OffsetCurve. getCurve()
Gets the computed offset curve lines.static Geometry
OffsetCurve. getCurve(Geometry geom, double distance)
Computes the offset curve of a geometry at a given distance.static Geometry
OffsetCurve. getCurve(Geometry geom, double distance, int quadSegs, int joinStyle, double mitreLimit)
Computes the offset curve of a geometry at a given distance, with specified quadrant segments, join style and mitre limit.static Geometry
OffsetCurve. getCurveJoined(Geometry geom, double distance)
Computes the offset curve of a geometry at a given distance, joining curve sections into a single line for each input line.Geometry
VariableBuffer. getResult()
Computes the variable buffer polygon.Geometry
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 Geometry Modifier and Type Method Description static Geometry
VariableBuffer. buffer(Geometry line, double[] distance)
Creates a buffer polygon along a line with the distance specified at each vertex.static Geometry
VariableBuffer. buffer(Geometry line, double startDistance, double endDistance)
Creates a buffer polygon along a line with the buffer distance interpolated between a start distance and an end distance.static Geometry
VariableBuffer. buffer(Geometry line, double startDistance, double midDistance, double endDistance)
Creates a buffer polygon along a line with the buffer distance interpolated between a start distance, a middle distance and an end distance.static Geometry
BufferOp. bufferByZero(Geometry geom, boolean isBothOrientations)
Buffers a geometry with distance zero.static Geometry
BufferOp. bufferOp(Geometry g, double distance)
Computes the buffer of a geometry for a given buffer distance.static Geometry
BufferOp. bufferOp(Geometry g, double distance, int quadrantSegments)
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
BufferOp. bufferOp(Geometry g, double distance, int quadrantSegments, int endCapStyle)
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
BufferOp. bufferOp(Geometry g, double distance, BufferParameters params)
Computes the buffer for a geometry for a given buffer distance and accuracy of approximation.static Geometry
OffsetCurve. getCurve(Geometry geom, double distance)
Computes the offset curve of a geometry at a given distance.static Geometry
OffsetCurve. getCurve(Geometry geom, double distance, int quadSegs, int joinStyle, double mitreLimit)
Computes the offset curve of a geometry at a given distance, with specified quadrant segments, join style and mitre limit.static Geometry
OffsetCurve. getCurveJoined(Geometry geom, double distance)
Computes the offset curve of a geometry at a given distance, joining curve sections into a single line for each input line.Constructors in org.locationtech.jts.operation.buffer with parameters of type Geometry Constructor Description BufferCurveSetBuilder(Geometry inputGeom, double distance, PrecisionModel precisionModel, BufferParameters bufParams)
BufferOp(Geometry g)
Initializes a buffer computation for the given geometryBufferOp(Geometry g, BufferParameters bufParams)
Initializes a buffer computation for the given geometry with the given set of parametersOffsetCurve(Geometry geom, double distance)
Creates a new instance for computing an offset curve for a geometry at a given distance.OffsetCurve(Geometry geom, double distance, BufferParameters bufParams)
Creates a new instance for computing an offset curve for a geometry at a given distance.VariableBuffer(Geometry line, double[] distance)
Creates a generator for a variable-distance line buffer. -
Uses of Geometry in org.locationtech.jts.operation.buffer.validate
Methods in org.locationtech.jts.operation.buffer.validate that return Geometry Modifier and Type Method Description Geometry
BufferDistanceValidator. getErrorIndicator()
Gets a geometry which indicates the location and nature of a validation failure.Geometry
BufferResultValidator. getErrorIndicator()
Gets a geometry which indicates the location and nature of a validation failure.Methods in org.locationtech.jts.operation.buffer.validate with parameters of type Geometry Modifier and Type Method Description static void
DistanceToPointFinder. computeDistance(Geometry geom, Coordinate pt, PointPairDistance ptDist)
double
BufferCurveMaximumDistanceFinder. findDistance(Geometry bufferCurve)
static boolean
BufferResultValidator. isValid(Geometry g, double distance, Geometry result)
static String
BufferResultValidator. isValidMsg(Geometry g, double distance, Geometry result)
Checks whether the geometry buffer is valid, and returns an error message if not.Constructors in org.locationtech.jts.operation.buffer.validate with parameters of type Geometry Constructor Description BufferCurveMaximumDistanceFinder(Geometry inputGeom)
BufferDistanceValidator(Geometry input, double bufDistance, Geometry result)
BufferResultValidator(Geometry input, double distance, Geometry result)
MaxMidpointDistanceFilter(Geometry geom)
MaxPointDistanceFilter(Geometry geom)
-
Uses of Geometry in org.locationtech.jts.operation.distance
Methods in org.locationtech.jts.operation.distance that return Geometry Modifier and Type Method Description Geometry
GeometryLocation. getGeometryComponent()
Returns the geometry component on (or in) which this location occurs.Methods in org.locationtech.jts.operation.distance with parameters of type Geometry Modifier and Type Method Description static STRtree
FacetSequenceTreeBuilder. build(Geometry g)
static Coordinate[]
DistanceOp. closestPoints(Geometry g0, Geometry g1)
Deprecated.renamed to nearestPointsstatic double
DistanceOp. distance(Geometry g0, Geometry g1)
Compute the distance between the nearest points of two geometries.double
IndexedFacetDistance. distance(Geometry g)
Computes the distance from the base geometry to the given geometry.static double
IndexedFacetDistance. distance(Geometry g1, Geometry g2)
Computes the distance between facets of two geometries.void
ConnectedElementLocationFilter. filter(Geometry geom)
void
ConnectedElementPointFilter. filter(Geometry geom)
static List
ConnectedElementPointFilter. getCoordinates(Geometry geom)
Returns a list containing a Coordinate from each Polygon, LineString, and Point found inside the specified geometry.static List
ConnectedElementLocationFilter. getLocations(Geometry geom)
Returns a list containing a point from each Polygon, LineString, and Point found inside the specified geometry.static boolean
DistanceOp. isWithinDistance(Geometry g0, Geometry g1, double distance)
Test whether two geometries lie within a given distance of each other.boolean
IndexedFacetDistance. isWithinDistance(Geometry g, double maxDistance)
Tests whether the base geometry lies within a specified distance of the given geometry.static boolean
IndexedFacetDistance. isWithinDistance(Geometry g1, Geometry g2, double distance)
Tests whether the facets of two geometries lie within a given distance.GeometryLocation[]
IndexedFacetDistance. nearestLocations(Geometry g)
Computes the nearest locations on the base geometry and the given geometry.static Coordinate[]
DistanceOp. nearestPoints(Geometry g0, Geometry g1)
Compute the the nearest points of two geometries.Coordinate[]
IndexedFacetDistance. nearestPoints(Geometry g)
Compute the nearest locations on the target geometry and the given geometry.static Coordinate[]
IndexedFacetDistance. nearestPoints(Geometry g1, Geometry g2)
Computes the nearest points of the facets of two geometries.Constructors in org.locationtech.jts.operation.distance with parameters of type Geometry Constructor Description DistanceOp(Geometry g0, Geometry g1)
Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries.DistanceOp(Geometry g0, Geometry g1, double terminateDistance)
Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries.FacetSequence(Geometry geom, CoordinateSequence pts, int start, int end)
Creates a new sequence of facets based on aCoordinateSequence
contained in the givenGeometry
.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.IndexedFacetDistance(Geometry geom)
Creates a new distance-finding instance for a given targetGeometry
. -
Uses of Geometry in org.locationtech.jts.operation.distance3d
Methods in org.locationtech.jts.operation.distance3d with parameters of type Geometry Modifier and Type Method Description static double
Distance3DOp. distance(Geometry g0, Geometry g1)
Compute the distance between the nearest points of two geometries.static boolean
Distance3DOp. isWithinDistance(Geometry g0, Geometry g1, double distance)
Test whether two geometries lie within a given distance of each other.static Coordinate[]
Distance3DOp. nearestPoints(Geometry g0, Geometry g1)
Compute the the nearest points of two geometries.Constructors in org.locationtech.jts.operation.distance3d with parameters of type Geometry Constructor Description Distance3DOp(Geometry g0, Geometry g1)
Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries.Distance3DOp(Geometry g0, Geometry g1, double terminateDistance)
Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries. -
Uses of Geometry in org.locationtech.jts.operation.linemerge
Methods in org.locationtech.jts.operation.linemerge that return Geometry Modifier and Type Method Description Geometry
LineSequencer. getSequencedLineStrings()
Returns theLineString
orMultiLineString
built by the sequencing process, if one exists.static Geometry
LineSequencer. sequence(Geometry geom)
Methods in org.locationtech.jts.operation.linemerge with parameters of type Geometry Modifier and Type Method Description void
LineMerger. add(Geometry geometry)
Adds a Geometry to be processed.void
LineSequencer. add(Geometry geometry)
Adds aGeometry
to be sequenced.static boolean
LineSequencer. isSequenced(Geometry geom)
Tests whether aGeometry
is sequenced correctly.static Geometry
LineSequencer. sequence(Geometry geom)
-
Uses of Geometry in org.locationtech.jts.operation.overlay
Methods in org.locationtech.jts.operation.overlay that return Geometry Modifier and Type Method Description static Geometry
OverlayOp. createEmptyResult(int overlayOpCode, Geometry a, Geometry b, GeometryFactory geomFact)
Creates an empty result geometry of the appropriate dimension, based on the given overlay operation and the dimensions of the inputs.Geometry
OverlayOp. getResultGeometry(int overlayOpCode)
Gets the result of the overlay for a given overlay operation.static Geometry
OverlayOp. overlayOp(Geometry geom0, Geometry geom1, int opCode)
Computes an overlay operation for the given geometry arguments.Methods in org.locationtech.jts.operation.overlay with parameters of type Geometry Modifier and Type Method Description static Geometry
OverlayOp. createEmptyResult(int overlayOpCode, Geometry a, Geometry b, GeometryFactory geomFact)
Creates an empty result geometry of the appropriate dimension, based on the given overlay operation and the dimensions of the inputs.static Geometry
OverlayOp. overlayOp(Geometry geom0, Geometry geom1, int opCode)
Computes an overlay operation for the given geometry arguments.Constructors in org.locationtech.jts.operation.overlay with parameters of type Geometry Constructor Description OverlayOp(Geometry g0, Geometry g1)
Constructs an instance to compute a single overlay operation for the given geometries. -
Uses of Geometry in org.locationtech.jts.operation.overlay.snap
Methods in org.locationtech.jts.operation.overlay.snap that return Geometry Modifier and Type Method Description static Geometry
SnapIfNeededOverlayOp. difference(Geometry g0, Geometry g1)
static Geometry
SnapOverlayOp. difference(Geometry g0, Geometry g1)
Geometry
SnapIfNeededOverlayOp. getResultGeometry(int opCode)
Geometry
SnapOverlayOp. getResultGeometry(int opCode)
static Geometry
SnapIfNeededOverlayOp. intersection(Geometry g0, Geometry g1)
static Geometry
SnapOverlayOp. intersection(Geometry g0, Geometry g1)
static Geometry
SnapIfNeededOverlayOp. overlayOp(Geometry g0, Geometry g1, int opCode)
static Geometry
SnapOverlayOp. overlayOp(Geometry g0, Geometry g1, int opCode)
static Geometry[]
GeometrySnapper. snap(Geometry g0, Geometry g1, double snapTolerance)
Snaps two geometries together with a given tolerance.Geometry
GeometrySnapper. snapTo(Geometry snapGeom, double snapTolerance)
Snaps the vertices in the componentLineString
s of the source geometry to the vertices of the given snap geometry.Geometry
GeometrySnapper. snapToSelf(double snapTolerance, boolean cleanResult)
Snaps the vertices in the 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
SnapIfNeededOverlayOp. union(Geometry g0, Geometry g1)
static Geometry
SnapOverlayOp. union(Geometry g0, Geometry g1)
Methods in org.locationtech.jts.operation.overlay.snap with parameters of type Geometry Modifier and Type Method Description static double
GeometrySnapper. computeOverlaySnapTolerance(Geometry g)
Estimates the snap tolerance for a Geometry, taking into account its precision model.static double
GeometrySnapper. computeOverlaySnapTolerance(Geometry g0, Geometry g1)
static double
GeometrySnapper. computeSizeBasedSnapTolerance(Geometry g)
static Geometry
SnapIfNeededOverlayOp. difference(Geometry g0, Geometry g1)
static Geometry
SnapOverlayOp. difference(Geometry g0, Geometry g1)
static Geometry
SnapIfNeededOverlayOp. intersection(Geometry g0, Geometry g1)
static Geometry
SnapOverlayOp. intersection(Geometry g0, Geometry g1)
static Geometry
SnapIfNeededOverlayOp. overlayOp(Geometry g0, Geometry g1, int opCode)
static Geometry
SnapOverlayOp. overlayOp(Geometry g0, Geometry g1, int opCode)
static Geometry[]
GeometrySnapper. snap(Geometry g0, Geometry g1, double snapTolerance)
Snaps two geometries together with a given tolerance.Geometry
GeometrySnapper. snapTo(Geometry snapGeom, double snapTolerance)
Snaps the vertices in the 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)
static Geometry
SnapIfNeededOverlayOp. union(Geometry g0, Geometry g1)
static Geometry
SnapOverlayOp. union(Geometry g0, Geometry g1)
Constructors in org.locationtech.jts.operation.overlay.snap with parameters of type Geometry Constructor Description GeometrySnapper(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
Methods in org.locationtech.jts.operation.overlay.validate with parameters of type Geometry Modifier and Type Method Description static boolean
OverlayResultValidator. isValid(Geometry a, Geometry b, int overlayOp, Geometry result)
Constructors in org.locationtech.jts.operation.overlay.validate with parameters of type Geometry Constructor Description FuzzyPointLocator(Geometry g, double boundaryDistanceTolerance)
OffsetPointGenerator(Geometry g)
OverlayResultValidator(Geometry a, Geometry b, Geometry result)
-
Uses of Geometry in org.locationtech.jts.operation.overlayarea
Methods in org.locationtech.jts.operation.overlayarea with parameters of type Geometry Modifier and Type Method Description static double
GeometryArea. area(Geometry geom)
double
OverlayArea. intersectionArea(Geometry geom)
static double
OverlayArea. intersectionArea(Geometry geom0, Geometry geom1)
Constructors in org.locationtech.jts.operation.overlayarea with parameters of type Geometry Constructor Description GeometryArea(Geometry geom)
OverlayArea(Geometry geom)
-
Uses of Geometry in org.locationtech.jts.operation.overlayng
Methods in org.locationtech.jts.operation.overlayng that return Geometry Modifier and Type Method Description Geometry
OverlayNG. getResult()
Gets the result of the overlay operation.Geometry
FastOverlayFilter. overlay(Geometry geom, int overlayOpCode)
Computes the overlay operation on the input geometries, if it can be determined that the result is either empty or equal to one of the input values.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode)
Computes an overlay operation on the given geometry operands, using the precision model of the geometry.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode, PrecisionModel pm)
Computes an overlay operation for the given geometry operands, with the noding strategy determined by the precision model.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode, PrecisionModel pm, Noder noder)
Computes an overlay operation on the given geometry operands, using a suppliedNoder
.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode, Noder noder)
Computes an overlay operation on the given geometry operands, using a suppliedNoder
.static Geometry
OverlayNGRobust. overlay(Geometry geom0, Geometry geom1, int opCode)
Overlay two geometries, using heuristics to ensure computation completes correctly.static Geometry
PrecisionReducer. reducePrecision(Geometry geom, PrecisionModel pm)
Reduces the precision of a geometry by rounding and snapping it to the suppliedPrecisionModel
.static Geometry
CoverageUnion. union(Geometry coverage)
Unions a valid polygonal coverage or linear network.static Geometry
OverlayNGRobust. union(Collection<Geometry> geoms)
Computes the unary union of a collection of geometries using robust computation.static Geometry
OverlayNGRobust. union(Collection<Geometry> geoms, GeometryFactory geomFact)
Computes the unary union of a collection of geometries using robust computation.static Geometry
OverlayNGRobust. union(Geometry geom)
Computes the unary union of a geometry using robust computation.static Geometry
UnaryUnionNG. union(Collection<Geometry> geoms, GeometryFactory geomFact, PrecisionModel pm)
Unions a collection of geometries using a given precision model.static Geometry
UnaryUnionNG. union(Collection<Geometry> geoms, PrecisionModel pm)
Unions a collection of geometries using a given precision model.static Geometry
UnaryUnionNG. union(Geometry geom, PrecisionModel pm)
Unions a geometry (which is often a collection) using a given precision model.Methods in org.locationtech.jts.operation.overlayng with parameters of type Geometry Modifier and Type Method Description static double
PrecisionUtil. inherentScale(Geometry geom)
Computes the inherent scale of a geometry.static double
PrecisionUtil. inherentScale(Geometry a, Geometry b)
Computes the inherent scale of two geometries.Geometry
FastOverlayFilter. overlay(Geometry geom, int overlayOpCode)
Computes the overlay operation on the input geometries, if it can be determined that the result is either empty or equal to one of the input values.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode)
Computes an overlay operation on the given geometry operands, using the precision model of the geometry.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode, PrecisionModel pm)
Computes an overlay operation for the given geometry operands, with the noding strategy determined by the precision model.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode, PrecisionModel pm, Noder noder)
Computes an overlay operation on the given geometry operands, using a suppliedNoder
.static Geometry
OverlayNG. overlay(Geometry geom0, Geometry geom1, int opCode, Noder noder)
Computes an overlay operation on the given geometry operands, using a suppliedNoder
.static Geometry
OverlayNGRobust. overlay(Geometry geom0, Geometry geom1, int opCode)
Overlay two geometries, using heuristics to ensure computation completes correctly.static Geometry
PrecisionReducer. reducePrecision(Geometry geom, PrecisionModel pm)
Reduces the precision of a geometry by rounding and snapping it to the suppliedPrecisionModel
.static PrecisionModel
PrecisionUtil. robustPM(Geometry a)
Determines a precision model to use for robust overlay operations for one geometry.static PrecisionModel
PrecisionUtil. robustPM(Geometry a, Geometry b)
Determines a precision model to use for robust overlay operations.static double
PrecisionUtil. robustScale(Geometry a)
Determines a scale factor which maximizes the digits of precision and is safe to use for overlay operations.static double
PrecisionUtil. robustScale(Geometry a, Geometry b)
Determines a scale factor which maximizes the digits of precision and is safe to use for overlay operations.static double
PrecisionUtil. safeScale(Geometry geom)
Computes a safe scale factor for a geometry.static double
PrecisionUtil. safeScale(Geometry a, Geometry b)
Computes a safe scale factor for two geometries.static Geometry
CoverageUnion. union(Geometry coverage)
Unions a valid polygonal coverage or linear network.static Geometry
OverlayNGRobust. union(Geometry geom)
Computes the unary union of a geometry using robust computation.static Geometry
UnaryUnionNG. union(Geometry geom, PrecisionModel pm)
Unions a geometry (which is often a collection) using a given precision model.Method parameters in org.locationtech.jts.operation.overlayng with type arguments of type Geometry Modifier and Type Method Description static Geometry
OverlayNGRobust. union(Collection<Geometry> geoms)
Computes the unary union of a collection of geometries using robust computation.static Geometry
OverlayNGRobust. union(Collection<Geometry> geoms, GeometryFactory geomFact)
Computes the unary union of a collection of geometries using robust computation.static Geometry
UnaryUnionNG. union(Collection<Geometry> geoms, GeometryFactory geomFact, PrecisionModel pm)
Unions a collection of geometries using a given precision model.static Geometry
UnaryUnionNG. union(Collection<Geometry> geoms, PrecisionModel pm)
Unions a collection of geometries using a given precision model.Constructors in org.locationtech.jts.operation.overlayng with parameters of type Geometry Constructor Description FastOverlayFilter(Geometry geom)
OverlayNG(Geometry geom0, Geometry geom1, int opCode)
Creates an overlay operation on the given geometries using the precision model of the geometries.OverlayNG(Geometry geom0, Geometry geom1, PrecisionModel pm, int opCode)
Creates an overlay operation on the given geometries, with a defined precision model. -
Uses of Geometry in org.locationtech.jts.operation.polygonize
Methods in org.locationtech.jts.operation.polygonize that return Geometry Modifier and Type Method Description Geometry
Polygonizer. getGeometry()
Gets a geometry representing the polygons formed by the polygonization.Methods in org.locationtech.jts.operation.polygonize with parameters of type Geometry Modifier and Type Method Description void
Polygonizer. add(Geometry g)
Add aGeometry
to the edges to be polygonized. -
Uses of Geometry in org.locationtech.jts.operation.predicate
Methods in org.locationtech.jts.operation.predicate with parameters of type Geometry Modifier and Type Method Description boolean
RectangleContains. contains(Geometry geom)
static boolean
RectangleContains. contains(Polygon rectangle, Geometry b)
Tests whether a rectangle contains a given geometry.boolean
RectangleIntersects. intersects(Geometry geom)
Tests whether the given Geometry intersects the query rectangle.static boolean
RectangleIntersects. intersects(Polygon rectangle, Geometry b)
Tests whether a rectangle intersects a given geometry. -
Uses of Geometry in org.locationtech.jts.operation.relate
Methods in org.locationtech.jts.operation.relate with parameters of type Geometry Modifier and Type Method Description static IntersectionMatrix
RelateOp. relate(Geometry a, Geometry b)
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 Constructor Description RelateOp(Geometry g0, Geometry g1)
Creates a new Relate operation, using the default (OGC SFS) Boundary Node Rule.RelateOp(Geometry g0, Geometry g1, BoundaryNodeRule boundaryNodeRule)
Creates a new Relate operation with a specified Boundary Node Rule. -
Uses of Geometry in org.locationtech.jts.operation.relateng
Methods in org.locationtech.jts.operation.relateng with parameters of type Geometry Modifier and Type Method Description IntersectionMatrix
RelateNG. evaluate(Geometry b)
Computes the DE-9IM matrix for the topological relationship to a geometry.boolean
RelateNG. evaluate(Geometry b, String imPattern)
Tests whether the topological relationship to a geometry matches a DE-9IM matrix pattern.boolean
RelateNG. evaluate(Geometry b, TopologyPredicate predicate)
Tests whether the topological relationship to a geometry satisfies a topology predicate.static RelateNG
RelateNG. prepare(Geometry a)
Creates a prepared RelateNG instance to optimize the evaluation of relationships against a single geometry.static RelateNG
RelateNG. prepare(Geometry a, BoundaryNodeRule bnRule)
Creates a prepared RelateNG instance to optimize the computation of predicates against a single geometry, using a givenBoundaryNodeRule
.static IntersectionMatrix
RelateNG. relate(Geometry a, Geometry b)
Computes the DE-9IM matrix for the topological relationship between two geometries.static boolean
RelateNG. relate(Geometry a, Geometry b, String imPattern)
Tests whether the topological relationship to a geometry matches a DE-9IM matrix pattern.static IntersectionMatrix
RelateNG. relate(Geometry a, Geometry b, BoundaryNodeRule bnRule)
Computes the DE-9IM matrix for the topological relationship between two geometries.static boolean
RelateNG. relate(Geometry a, Geometry b, TopologyPredicate pred)
Tests whether the topological relationship between two geometries satisfies a topological predicate.static boolean
RelateNG. relate(Geometry a, Geometry b, TopologyPredicate pred, BoundaryNodeRule bnRule)
Tests whether the topological relationship between two geometries satisfies a topological predicate, using a givenBoundaryNodeRule
. -
Uses of Geometry in org.locationtech.jts.operation.union
Methods in org.locationtech.jts.operation.union that return Geometry Modifier and Type Method Description Geometry
SpatialPartition. getGeometry(int s, int i)
Gets a geometry in a given partitionGeometry
CascadedPolygonUnion. union()
Computes the union of the input geometries.static Geometry
CascadedPolygonUnion. union(Collection polys)
static Geometry
CascadedPolygonUnion. union(Collection polys, UnionStrategy unionFun)
Geometry
OverlapUnion. union()
Deprecated.Unions the input geometries, using the more performant overlap union algorithm if possible.static Geometry
OverlapUnion. union(Geometry g0, Geometry g1, UnionStrategy unionFun)
Deprecated.Union a pair of geometries, using the more performant overlap union algorithm if possible.Geometry
PartitionedUnion. union()
static Geometry
PartitionedUnion. union(Geometry geoms)
Geometry
PointGeometryUnion. union()
static Geometry
PointGeometryUnion. union(Puntal pointGeom, Geometry otherGeom)
Geometry
SparsePolygonUnion. union()
static Geometry
SparsePolygonUnion. union(Collection geoms)
static Geometry
SparsePolygonUnion. union(Geometry geoms)
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
UnaryUnionOp. union(Geometry geom)
Constructs a unary union operation for aGeometry
(which may be aGeometryCollection
).Geometry
UnionInteracting. union()
static Geometry
UnionInteracting. union(Geometry g0, Geometry g1)
Geometry
UnionStrategy. union(Geometry g0, Geometry g1)
Computes the union of two geometries.Methods in org.locationtech.jts.operation.union with parameters of type Geometry Modifier and Type Method Description static Geometry
OverlapUnion. union(Geometry g0, Geometry g1, UnionStrategy unionFun)
Deprecated.Union a pair of geometries, using the more performant overlap union algorithm if possible.static Geometry
PartitionedUnion. union(Geometry geoms)
static Geometry
PointGeometryUnion. union(Puntal pointGeom, Geometry otherGeom)
static Geometry
SparsePolygonUnion. union(Geometry geoms)
static Geometry
UnaryUnionOp. union(Geometry geom)
Constructs a unary union operation for aGeometry
(which may be aGeometryCollection
).static Geometry
UnionInteracting. union(Geometry g0, Geometry g1)
Geometry
UnionStrategy. union(Geometry g0, Geometry g1)
Computes the union of two geometries.Constructors in org.locationtech.jts.operation.union with parameters of type Geometry Constructor Description OverlapUnion(Geometry g0, Geometry g1)
Deprecated.Creates a new instance for unioning the given geometries.OverlapUnion(Geometry g0, Geometry g1, UnionStrategy unionFun)
Deprecated.PointGeometryUnion(Puntal pointGeom, Geometry otherGeom)
SpatialPartition(Geometry[] geoms, SpatialPartition.EquivalenceRelation rel)
UnaryUnionOp(Geometry geom)
Constructs a unary union operation for aGeometry
(which may be aGeometryCollection
).UnionInteracting(Geometry g0, Geometry g1)
Constructor parameters in org.locationtech.jts.operation.union with type arguments of type Geometry Constructor Description PartitionedUnion(Collection<Geometry> polys)
SparsePolygonUnion(Collection<Geometry> polys)
-
Uses of Geometry in org.locationtech.jts.operation.valid
Methods in org.locationtech.jts.operation.valid with parameters of type Geometry Modifier and Type Method Description static Coordinate
IsSimpleOp. getNonSimpleLocation(Geometry geom)
Gets a non-simple location in a geometry, if any.boolean
RepeatedPointTester. hasRepeatedPoint(Geometry g)
static boolean
IsSimpleOp. isSimple(Geometry geom)
Tests whether a geometry is simple.static boolean
IsValidOp. isValid(Geometry geom)
Tests whether aGeometry
is valid.Constructors in org.locationtech.jts.operation.valid with parameters of type Geometry Constructor Description 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
IsValidOp(Geometry inputGeometry)
Creates a new validator for a geometry. -
Uses of Geometry in org.locationtech.jts.precision
Methods in org.locationtech.jts.precision that return Geometry Modifier and Type Method Description Geometry
CommonBitsOp. buffer(Geometry geom0, double distance)
Computes the buffer a geometry, using enhanced precision.static Geometry
EnhancedPrecisionOp. buffer(Geometry geom, double distance)
Computes the buffer of aGeometry
, using enhanced precision.Geometry
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.static Geometry
MinimumClearance. getLine(Geometry g)
Gets a LineString containing two points which are at the Minimum Clearance distance for the given Geometry.static Geometry
SimpleMinimumClearance. getLine(Geometry g)
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.Geometry
GeometryPrecisionReducer. reduce(Geometry geom)
Reduces the precision of a geometry, according to the specified strategy of this reducer.static Geometry
GeometryPrecisionReducer. reduce(Geometry g, PrecisionModel precModel)
Reduces precision of a geometry, ensuring output geometry is valid.Geometry
SimpleGeometryPrecisionReducer. reduce(Geometry geom)
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.static Geometry
GeometryPrecisionReducer. reduceKeepCollapsed(Geometry geom, PrecisionModel pm)
Reduces precision of a geometry, ensuring output polygonal geometry is valid, and preserving collapsed linear elements.static Geometry
GeometryPrecisionReducer. reducePointwise(Geometry g, PrecisionModel precModel)
Reduce precision of a geometry in a pointwise way.Geometry
CommonBitsRemover. removeCommonBits(Geometry geom)
Removes the common coordinate bits from a Geometry.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.Geometry
CommonBitsOp. union(Geometry geom0, Geometry geom1)
Computes the set-theoretic union of twoGeometry
s, using enhanced precision.static Geometry
EnhancedPrecisionOp. union(Geometry geom0, Geometry geom1)
Computes the set-theoretic union of twoGeometry
s, using enhanced precision.Methods in org.locationtech.jts.precision with parameters of type Geometry Modifier and Type Method Description void
CommonBitsRemover. add(Geometry geom)
Add a geometry to the set of geometries whose common bits are being computed.void
CommonBitsRemover. addCommonBits(Geometry geom)
Adds the common coordinate bits back into a Geometry.Geometry
CommonBitsOp. buffer(Geometry geom0, double distance)
Computes the buffer a geometry, using enhanced precision.static Geometry
EnhancedPrecisionOp. buffer(Geometry geom, double distance)
Computes the buffer of aGeometry
, using enhanced precision.Geometry
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.Coordinate[]
PrecisionReducerCoordinateOperation. edit(Coordinate[] coordinates, 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
MinimumClearance. getLine(Geometry g)
Gets a LineString containing two points which are at the Minimum Clearance distance for the given Geometry.static Geometry
SimpleMinimumClearance. getLine(Geometry g)
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.Geometry
GeometryPrecisionReducer. reduce(Geometry geom)
Reduces the precision of a geometry, according to the specified strategy of this reducer.static Geometry
GeometryPrecisionReducer. reduce(Geometry g, PrecisionModel precModel)
Reduces precision of a geometry, ensuring output geometry is valid.Geometry
SimpleGeometryPrecisionReducer. reduce(Geometry geom)
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.static Geometry
GeometryPrecisionReducer. reduceKeepCollapsed(Geometry geom, PrecisionModel pm)
Reduces precision of a geometry, ensuring output polygonal geometry is valid, and preserving collapsed linear elements.static Geometry
GeometryPrecisionReducer. reducePointwise(Geometry g, PrecisionModel precModel)
Reduce precision of a geometry in a pointwise way.Geometry
CommonBitsRemover. removeCommonBits(Geometry geom)
Removes the common coordinate bits from a Geometry.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.Geometry
CommonBitsOp. union(Geometry geom0, Geometry geom1)
Computes the set-theoretic union of twoGeometry
s, using enhanced precision.static Geometry
EnhancedPrecisionOp. union(Geometry geom0, Geometry geom1)
Computes the set-theoretic union of twoGeometry
s, using enhanced precision.Constructors in org.locationtech.jts.precision with parameters of type Geometry Constructor Description MinimumClearance(Geometry geom)
Creates an object to compute the Minimum Clearance for the given GeometrySimpleMinimumClearance(Geometry geom)
-
Uses of Geometry in org.locationtech.jts.shape
Methods in org.locationtech.jts.shape that return Geometry Modifier and Type Method Description static Geometry
CubicBezierCurve. bezierCurve(Geometry geom, double alpha)
Creates a geometry of linearized Cubic Bezier Curves defined by the segments of the input and a parameter controlling how curved the result should be.static Geometry
CubicBezierCurve. bezierCurve(Geometry geom, double alpha, double skew)
Creates a geometry of linearized Cubic Bezier Curves defined by the segments of the input and a parameter controlling how curved the result should be, with a skew factor affecting the curve shape at each vertex.static Geometry
CubicBezierCurve. bezierCurve(Geometry geom, Geometry controlPoints)
Creates a geometry of linearized Cubic Bezier Curves defined by the segments of the input and a list (or lists) of control points.abstract Geometry
GeometricShapeBuilder. getGeometry()
Geometry
CubicBezierCurve. getResult()
Gets the computed linearized Bezier curve geometry.Methods in org.locationtech.jts.shape with parameters of type Geometry Modifier and Type Method Description static Geometry
CubicBezierCurve. bezierCurve(Geometry geom, double alpha)
Creates a geometry of linearized Cubic Bezier Curves defined by the segments of the input and a parameter controlling how curved the result should be.static Geometry
CubicBezierCurve. bezierCurve(Geometry geom, double alpha, double skew)
Creates a geometry of linearized Cubic Bezier Curves defined by the segments of the input and a parameter controlling how curved the result should be, with a skew factor affecting the curve shape at each vertex.static Geometry
CubicBezierCurve. bezierCurve(Geometry geom, Geometry controlPoints)
Creates a geometry of linearized Cubic Bezier Curves defined by the segments of the input and a list (or lists) of control points. -
Uses of Geometry in org.locationtech.jts.shape.fractal
Methods in org.locationtech.jts.shape.fractal that return Geometry Modifier and Type Method Description Geometry
HilbertCurveBuilder. getGeometry()
Geometry
KochSnowflakeBuilder. getGeometry()
Geometry
MortonCurveBuilder. getGeometry()
Geometry
SierpinskiCarpetBuilder. getGeometry()
-
Uses of Geometry in org.locationtech.jts.shape.random
Fields in org.locationtech.jts.shape.random declared as Geometry Modifier and Type Field Description protected Geometry
RandomPointsBuilder. maskPoly
Methods in org.locationtech.jts.shape.random that return Geometry Modifier and Type Method Description Geometry
RandomPointsBuilder. getGeometry()
Geometry
RandomPointsInGridBuilder. getGeometry()
Gets theMultiPoint
containing the generated pointMethods in org.locationtech.jts.shape.random with parameters of type Geometry Modifier and Type Method Description void
RandomPointsBuilder. setExtent(Geometry mask)
Sets a polygonal mask. -
Uses of Geometry in org.locationtech.jts.simplify
Methods in org.locationtech.jts.simplify that return Geometry Modifier and Type Method Description Geometry
PolygonHullSimplifier. getResult()
Gets the result polygonal hull geometry.Geometry
DouglasPeuckerSimplifier. getResultGeometry()
Gets the simplified geometry.Geometry
TopologyPreservingSimplifier. getResultGeometry()
Geometry
VWSimplifier. getResultGeometry()
Gets the simplified geometry.static Geometry
PolygonHullSimplifier. hull(Geometry geom, boolean isOuter, double vertexNumFraction)
Computes a topology-preserving simplified hull of a polygonal geometry, with hull shape determined by a target parameter specifying the fraction of the input vertices retained in the result.static Geometry
PolygonHullSimplifier. hullByAreaDelta(Geometry geom, boolean isOuter, double areaDeltaRatio)
Computes a topology-preserving simplified hull of a polygonal geometry, with hull shape determined by a target parameter specifying the ratio of maximum difference in area to original area.static Geometry
DouglasPeuckerSimplifier. simplify(Geometry geom, double distanceTolerance)
Simplifies a geometry using a given tolerance.static Geometry
TopologyPreservingSimplifier. simplify(Geometry geom, double distanceTolerance)
static Geometry
VWSimplifier. simplify(Geometry geom, double distanceTolerance)
Simplifies a geometry using a given tolerance.Methods in org.locationtech.jts.simplify with parameters of type Geometry Modifier and Type Method Description static Geometry
PolygonHullSimplifier. hull(Geometry geom, boolean isOuter, double vertexNumFraction)
Computes a topology-preserving simplified hull of a polygonal geometry, with hull shape determined by a target parameter specifying the fraction of the input vertices retained in the result.static Geometry
PolygonHullSimplifier. hullByAreaDelta(Geometry geom, boolean isOuter, double areaDeltaRatio)
Computes a topology-preserving simplified hull of a polygonal geometry, with hull shape determined by a target parameter specifying the ratio of maximum difference in area to original area.static Geometry
DouglasPeuckerSimplifier. simplify(Geometry geom, double distanceTolerance)
Simplifies a geometry using a given tolerance.static Geometry
TopologyPreservingSimplifier. simplify(Geometry geom, double distanceTolerance)
static Geometry
VWSimplifier. simplify(Geometry geom, double distanceTolerance)
Simplifies a geometry using a given tolerance.Constructors in org.locationtech.jts.simplify with parameters of type Geometry Constructor Description DouglasPeuckerSimplifier(Geometry inputGeom)
Creates a simplifier for a given geometry.PolygonHullSimplifier(Geometry inputGeom, boolean isOuter)
Creates a new instance to compute a simplified hull of a polygonal geometry.TopologyPreservingSimplifier(Geometry inputGeom)
VWSimplifier(Geometry inputGeom)
Creates a simplifier for a given geometry. -
Uses of Geometry in org.locationtech.jts.triangulate
Methods in org.locationtech.jts.triangulate that return Geometry Modifier and Type Method Description Geometry
ConformingDelaunayTriangulator. getConvexHull()
Gets the convex hull of all the sites in the triangulation, including constraint vertices.Geometry
VoronoiDiagramBuilder. getDiagram(GeometryFactory geomFact)
Gets the faces of the computed diagram as aGeometryCollection
ofPolygon
s, clipped as specified.Geometry
ConformingDelaunayTriangulationBuilder. getEdges(GeometryFactory geomFact)
Gets the edges of the computed triangulation as aMultiLineString
.Geometry
DelaunayTriangulationBuilder. getEdges(GeometryFactory geomFact)
Gets the edges of the computed triangulation as aMultiLineString
.Geometry
ConformingDelaunayTriangulationBuilder. getTriangles(GeometryFactory geomFact)
Gets the faces of the computed triangulation as aGeometryCollection
ofPolygon
.Geometry
DelaunayTriangulationBuilder. getTriangles(GeometryFactory geomFact)
Gets the faces of the computed triangulation as aGeometryCollection
ofPolygon
.Methods in org.locationtech.jts.triangulate with parameters of type Geometry Modifier and Type Method Description 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
ConformingDelaunayTriangulationBuilder. setSites(Geometry geom)
Sets the sites (point or vertices) which will be triangulated.void
DelaunayTriangulationBuilder. setSites(Geometry geom)
Sets the sites (vertices) which will be triangulated.void
VoronoiDiagramBuilder. setSites(Geometry geom)
Sets the sites (point or vertices) which will be diagrammed.void
VertexTaggedGeometryDataMapper. transferData(Geometry targetGeom)
Input is assumed to be a multiGeometry in which every component has its userData set to be a Coordinate which is the key to the output data. -
Uses of Geometry in org.locationtech.jts.triangulate.polygon
Methods in org.locationtech.jts.triangulate.polygon that return Geometry Modifier and Type Method Description Geometry
ConstrainedDelaunayTriangulator. getResult()
Gets the triangulation as aGeometryCollection
of triangularPolygon
s.Geometry
PolygonTriangulator. getResult()
Gets the triangulation as aGeometryCollection
of triangularPolygon
s.static Geometry
ConstrainedDelaunayTriangulator. triangulate(Geometry geom)
Computes the Constrained Delaunay Triangulation of each polygon element in a geometry.static Geometry
PolygonTriangulator. triangulate(Geometry geom)
Computes a triangulation of each polygon in a geometry.Methods in org.locationtech.jts.triangulate.polygon with parameters of type Geometry Modifier and Type Method Description static Geometry
ConstrainedDelaunayTriangulator. triangulate(Geometry geom)
Computes the Constrained Delaunay Triangulation of each polygon element in a geometry.static Geometry
PolygonTriangulator. triangulate(Geometry geom)
Computes a triangulation of each polygon in a geometry.Constructors in org.locationtech.jts.triangulate.polygon with parameters of type Geometry Constructor Description ConstrainedDelaunayTriangulator(Geometry inputGeom)
Constructs a new Constrained Delaunay triangulator.PolygonTriangulator(Geometry inputGeom)
Constructs a new triangulator. -
Uses of Geometry in org.locationtech.jts.triangulate.quadedge
Methods in org.locationtech.jts.triangulate.quadedge that return Geometry Modifier and Type Method Description Geometry
QuadEdgeSubdivision. getEdges(GeometryFactory geomFact)
Gets the geometry for the edges in the subdivision as aMultiLineString
containing 2-point lines.Geometry
QuadEdgeSubdivision. getTriangles(boolean includeFrame, GeometryFactory geomFact)
Gets the geometry for the triangles in a triangulated subdivision as aGeometryCollection
of triangularPolygon
s, optionally including the frame triangles.Geometry
QuadEdgeSubdivision. getTriangles(GeometryFactory geomFact)
Gets the geometry for the triangles in a triangulated subdivision as aGeometryCollection
of triangularPolygon
s.Geometry
QuadEdgeSubdivision. getVoronoiDiagram(GeometryFactory geomFact)
Gets the cells in the Voronoi diagram for this triangulation.static Geometry
QuadEdgeTriangle. toPolygon(QuadEdge[] e)
static Geometry
QuadEdgeTriangle. toPolygon(Vertex[] v)
-
Uses of Geometry in org.locationtech.jts.triangulate.tri
Methods in org.locationtech.jts.triangulate.tri that return Geometry Modifier and Type Method Description static Geometry
Tri. toGeometry(Collection<Tri> tris, GeometryFactory geomFact)
Creates aGeometryCollection
ofPolygon
s representing the triangles in a list. -
Uses of Geometry in org.locationtech.jts.util
Methods in org.locationtech.jts.util that return Geometry Modifier and Type Method Description protected Geometry
GeometricShapeFactory. rotate(Geometry geom)
Methods in org.locationtech.jts.util with parameters of type Geometry Modifier and Type Method Description static boolean
Debug. hasSegment(Geometry geom, Coordinate p0, Coordinate p1)
protected Geometry
GeometricShapeFactory. rotate(Geometry geom)
static void
TestBuilderProxy. showIndicator(Geometry geom)
Shows a geometry as an indicator in the TestBuilder Edit panel.static void
TestBuilderProxy. showIndicator(Geometry geom, Color lineClr)
Shows a geometry as an indicator in the TestBuilder Edit panel. -
Uses of Geometry in org.locationtech.jtsexample.technique
Methods in org.locationtech.jtsexample.technique that return Geometry Modifier and Type Method Description static Geometry
LineStringSelfIntersections. getEndPoints(Geometry g)
static Geometry
LineStringSelfIntersections. lineStringSelfIntersections(LineString line)
Methods in org.locationtech.jtsexample.technique with parameters of type Geometry Modifier and Type Method Description static Geometry
LineStringSelfIntersections. getEndPoints(Geometry g)
static void
PolygonUnionUsingBuffer. unionUsingBuffer(Geometry[] geom)
Deprecated. -
Uses of Geometry in org.locationtech.jtslab
Methods in org.locationtech.jtslab that return Geometry Modifier and Type Method Description static Geometry
ClipFunctions. clipByIntersection(Geometry geom, Geometry rectangle)
static Geometry
ClipFunctions. clipByIntersectionOpt(Geometry geom, Geometry rectangle)
static Geometry
ClipFunctions. clipPoly(Geometry geom, Geometry rectangle)
static Geometry
ClipFunctions. clipPolyPrecise(Geometry geom, Geometry rectangle, double scaleFactor)
static Geometry
OverlayAreaFunctions. intAreaOrigData(Geometry geom0, Geometry geom1)
static Geometry
OverlayAreaFunctions. intAreaOrigPrepData(Geometry geom0, Geometry geom1)
static Geometry
OverlayAreaFunctions. intersectionAreaData(Geometry geom0, Geometry geom1)
static Geometry
OverlayAreaFunctions. intersectionAreaPrepData(Geometry geom0, Geometry geom1)
static Geometry
OverlayOptFunctions. intersectionOpt(Geometry a, Geometry b)
Use spatial predicates as a filter in front of intersection.static Geometry
OverlayOptFunctions. intersectionOptPrep(Geometry a, Geometry b)
Use prepared geometry spatial predicates as a filter in front of intersection, with the first operand prepared.static Geometry
IteratedOverlayFunctions. overlayIndexedNG(Geometry coll)
static Geometry
IteratedOverlayFunctions. overlayNG(Geometry coll)
static Geometry
IteratedOverlayFunctions. overlayOld(Geometry coll)
static Geometry
IteratedOverlayFunctions. overlaySR(Geometry coll, double scale)
static Geometry
RemoverFunctions. removeSmallHoles(Geometry geom, double areaTolerance)
Methods in org.locationtech.jtslab with parameters of type Geometry Modifier and Type Method Description static double
EdgeRayFunctions. area(Geometry g)
static double
OverlayAreaFunctions. areaSingle(Geometry g)
static double
OverlayAreaFunctions. checkIntArea(Geometry geom0, Geometry geom1)
static double
EdgeRayFunctions. checkIntersectionArea(Geometry geom0, Geometry geom1)
static Geometry
ClipFunctions. clipByIntersection(Geometry geom, Geometry rectangle)
static Geometry
ClipFunctions. clipByIntersectionOpt(Geometry geom, Geometry rectangle)
static Geometry
ClipFunctions. clipPoly(Geometry geom, Geometry rectangle)
static Geometry
ClipFunctions. clipPolyPrecise(Geometry geom, Geometry rectangle, double scaleFactor)
static double
OverlayAreaFunctions. intAreaOrig(Geometry geom0, Geometry geom1)
static Geometry
OverlayAreaFunctions. intAreaOrigData(Geometry geom0, Geometry geom1)
static double
OverlayAreaFunctions. intAreaOrigPrep(Geometry geom0, Geometry geom1)
static Geometry
OverlayAreaFunctions. intAreaOrigPrepData(Geometry geom0, Geometry geom1)
static double
EdgeRayFunctions. intersectionArea(Geometry geom0, Geometry geom1)
static double
OverlayAreaFunctions. intersectionArea(Geometry geom0, Geometry geom1)
static Geometry
OverlayAreaFunctions. intersectionAreaData(Geometry geom0, Geometry geom1)
static double
OverlayAreaFunctions. intersectionAreaPrep(Geometry geom0, Geometry geom1)
static Geometry
OverlayAreaFunctions. intersectionAreaPrepData(Geometry geom0, Geometry geom1)
static Geometry
OverlayOptFunctions. intersectionOpt(Geometry a, Geometry b)
Use spatial predicates as a filter in front of intersection.static Geometry
OverlayOptFunctions. intersectionOptPrep(Geometry a, Geometry b)
Use prepared geometry spatial predicates as a filter in front of intersection, with the first operand prepared.static Geometry
IteratedOverlayFunctions. overlayIndexedNG(Geometry coll)
static Geometry
IteratedOverlayFunctions. overlayNG(Geometry coll)
static Geometry
IteratedOverlayFunctions. overlayOld(Geometry coll)
static Geometry
IteratedOverlayFunctions. overlaySR(Geometry coll, double scale)
static Geometry
RemoverFunctions. removeSmallHoles(Geometry geom, double areaTolerance)
-
Uses of Geometry in org.locationtech.jtslab.clean
Methods in org.locationtech.jtslab.clean that return Geometry Modifier and Type Method Description static Geometry
InvalidHoleRemover. clean(Geometry geom)
Removes invalid holes from the polygons in a geometry.static Geometry
SmallHoleRemover. clean(Geometry geom, double areaTolerance)
Removes small holes from the polygons in a geometry.Geometry
HoleRemover. getResult()
Gets the cleaned geometry.Geometry
InvalidHoleRemover. getResult()
Gets the cleaned geometry.Methods in org.locationtech.jtslab.clean with parameters of type Geometry Modifier and Type Method Description static Geometry
InvalidHoleRemover. clean(Geometry geom)
Removes invalid holes from the polygons in a geometry.static Geometry
SmallHoleRemover. clean(Geometry geom, double areaTolerance)
Removes small holes from the polygons in a geometry.boolean
HoleRemover.Predicate. value(Geometry geom)
Constructors in org.locationtech.jtslab.clean with parameters of type Geometry Constructor Description HoleRemover(Geometry geom, HoleRemover.Predicate isRemoved)
Creates a new hole remover instance.InvalidHoleRemover(Geometry geom)
Creates a new invalid hole remover instance. -
Uses of Geometry in org.locationtech.jtslab.clip
Methods in org.locationtech.jtslab.clip that return Geometry Modifier and Type Method Description Geometry
RectangleClipPolygon. clip(Geometry geom)
static Geometry
RectangleClipPolygon. clip(Geometry geom, Geometry rectangle)
static Geometry
RectangleClipPolygon. clip(Geometry geom, Geometry rectangle, PrecisionModel pm)
Geometry
RectangleClipPolygon. clipCollection(Geometry geom)
Methods in org.locationtech.jtslab.clip with parameters of type Geometry Modifier and Type Method Description Geometry
RectangleClipPolygon. clip(Geometry geom)
static Geometry
RectangleClipPolygon. clip(Geometry geom, Geometry rectangle)
static Geometry
RectangleClipPolygon. clip(Geometry geom, Geometry rectangle, PrecisionModel pm)
Geometry
RectangleClipPolygon. clipCollection(Geometry geom)
Constructors in org.locationtech.jtslab.clip with parameters of type Geometry Constructor Description RectangleClipPolygon(Geometry clipRectangle)
RectangleClipPolygon(Geometry clipRectangle, PrecisionModel pm)
-
Uses of Geometry in org.locationtech.jtslab.edgeray
Methods in org.locationtech.jtslab.edgeray with parameters of type Geometry Modifier and Type Method Description static double
EdgeRayArea. area(Geometry geom)
static double
EdgeRayIntersectionArea. area(Geometry geom0, Geometry geom1)
Constructors in org.locationtech.jtslab.edgeray with parameters of type Geometry Constructor Description EdgeRayArea(Geometry geom)
EdgeRayIntersectionArea(Geometry geom0, Geometry geom1)
-
Uses of Geometry in org.locationtech.jtslab.geom.util
Methods in org.locationtech.jtslab.geom.util that return Geometry Modifier and Type Method Description Geometry
GeometryEditorEx.CoordinateOperation. edit(Geometry geometry, GeometryFactory targetFactory)
Geometry
GeometryEditorEx.CoordinateSequenceOperation. edit(Geometry geometry, GeometryFactory targetFactory)
Geometry
GeometryEditorEx. edit(Geometry geometry)
Edit aGeometry
.Geometry
GeometryEditorEx.GeometryEditorOperation. edit(Geometry geometry, GeometryFactory targetFactory)
Edits a Geometry by returning a new Geometry with a modification.Geometry
GeometryEditorEx.NoOpGeometryOperation. edit(Geometry geometry, GeometryFactory targetFactory)
Methods in org.locationtech.jtslab.geom.util with parameters of type Geometry Modifier and Type Method Description abstract Coordinate[]
GeometryEditorEx.CoordinateOperation. edit(Coordinate[] coordinates, Geometry geometry)
Edits the array ofCoordinate
s from aGeometry
.Geometry
GeometryEditorEx.CoordinateOperation. edit(Geometry geometry, GeometryFactory targetFactory)
abstract CoordinateSequence
GeometryEditorEx.CoordinateSequenceOperation. edit(CoordinateSequence coordSeq, Geometry geometry, GeometryFactory targetFactory)
Edits aCoordinateSequence
from aGeometry
.Geometry
GeometryEditorEx.CoordinateSequenceOperation. edit(Geometry geometry, GeometryFactory targetFactory)
Geometry
GeometryEditorEx. edit(Geometry geometry)
Edit aGeometry
.Geometry
GeometryEditorEx.GeometryEditorOperation. edit(Geometry geometry, GeometryFactory targetFactory)
Edits a Geometry by returning a new Geometry with a modification.Geometry
GeometryEditorEx.NoOpGeometryOperation. edit(Geometry geometry, GeometryFactory targetFactory)
-
Uses of Geometry in org.locationtech.jtstest.clean
Methods in org.locationtech.jtstest.clean that return Geometry Modifier and Type Method Description Geometry
CleanDuplicatePoints. clean(Geometry g)
Methods in org.locationtech.jtstest.clean with parameters of type Geometry Modifier and Type Method Description Geometry
CleanDuplicatePoints. clean(Geometry g)
-
Uses of Geometry in org.locationtech.jtstest.cmd
Methods in org.locationtech.jtstest.cmd that return types with arguments of type Geometry Modifier and Type Method Description List<Geometry>
JTSOpCmd. getResultGeometry()
List<Geometry>
JTSOpRunner. getResultGeometry()
Methods in org.locationtech.jtstest.cmd with parameters of type Geometry Modifier and Type Method Description void
GeometryOutput. printGeometry(Geometry geom, int srid, String outputFormat)
static String
GeometryOutput. writeGeometrySummary(String label, Geometry g)
Method parameters in org.locationtech.jtstest.cmd with type arguments of type Geometry Modifier and Type Method Description static String
GeometryOutput. writeGeometrySummary(String label, List<Geometry> geoms)
-
Uses of Geometry in org.locationtech.jtstest.function
Methods in org.locationtech.jtstest.function that return Geometry Modifier and Type Method Description static Geometry
EditFunctions. addHole(Geometry polyGeom, Geometry hole)
static Geometry
GeometryFunctions. addHoles(Geometry g, Geometry holeGeom)
static Geometry
SelectionNGFunctions. adjacent(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. adjacentPrep(Geometry a, Geometry mask)
static Geometry
HullFunctions. alphaShape(Geometry geom, double alpha)
static Geometry
HullFunctions. alphaShapeWithHoles(Geometry geom, double alpha)
static Geometry
TriangleFunctions. angleBisectors(Geometry g)
static Geometry
UserDataFunctions. area(Geometry g)
static Geometry
SelectionFunctions. areaGreaterThan(Geometry a, double minArea)
static Geometry
SelectionFunctions. areaLessThan(Geometry a, double maxArea)
static Geometry
SelectionFunctions. areaZero(Geometry a)
static Geometry
CreateShapeFunctions. bezierCurve(Geometry geom, double alpha)
static Geometry
CreateShapeFunctions. bezierCurveControl(Geometry geom, Geometry controlPoints)
static Geometry
CreateShapeFunctions. bezierCurveSkew(Geometry geom, double alpha, double skew)
static Geometry
BoundaryFunctions. boundary(Geometry g)
static Geometry
ConstructionFunctions. boundary(Geometry g)
static Geometry
BoundaryFunctions. boundaryEndpoint(Geometry g)
static Geometry
BoundaryFunctions. boundaryMod2(Geometry g)
static Geometry
BoundaryFunctions. boundaryMonoValentEnd(Geometry g)
static Geometry
BoundaryFunctions. boundaryMultiValentEnd(Geometry g)
static Geometry
BufferFunctions. buffer(Geometry g, double distance)
static Geometry
BufferFunctions. bufferAndInverse(Geometry g, double distance)
static Geometry
BufferByUnionFunctions. bufferByComponents(Geometry g, double distance)
static Geometry
BufferByUnionFunctions. bufferBySections(Geometry g, double distance, int maxChainSize)
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. bufferRadius(Geometry radiusLine)
static Geometry
BufferFunctions. bufferValidated(Geometry g, double distance)
static Geometry
BufferFunctions. bufferValidatedGeom(Geometry g, double distance)
static Geometry
BufferFunctions. bufferWithParams(Geometry g, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static Geometry
BufferFunctions. bufferWithSimplify(Geometry g, Double distance, Double simplifyFactor)
static Geometry
FunctionsUtil. buildGeometry(List geoms, Geometry parentGeom)
static Geometry
FunctionsUtil. buildGeometry(Geometry[] geoms)
static Geometry
FunctionsUtil. buildGeometry(Geometry a, Geometry b)
static Geometry
FunctionsUtil. buildGeometryCollection(Geometry[] geoms, Geometry nullGeom)
static Geometry
ConstructionFunctions. centroid(Geometry g)
static Geometry
TriangleFunctions. centroid(Geometry g)
static Geometry
ConstructionFunctions. circleByRadiusLine(Geometry radiusLine, int nPts)
static Geometry
TriangleFunctions. circumcentre(Geometry g)
static Geometry
TriangleFunctions. circumcentreDD(Geometry g)
static Geometry
TriangleFunctions. circumcircle(Geometry g, int quadSegs)
static Geometry
OverlayFunctions. clip(Geometry a, Geometry mask)
static Geometry
OverlayNGTestFunctions. clipRing(Geometry line, Geometry box)
static Geometry
CreateShapeFunctions. comb(Geometry g, int nArms)
static Geometry
BufferByUnionFunctions. componentBuffers(Geometry g, double distance)
static Geometry
HullFunctions. concaveFill(Geometry geom, double maxEdgeLen)
static Geometry
HullFunctions. concaveFillByLenRatio(Geometry geom, double maxEdgeLenRatio)
static Geometry
ConstructionFunctions. concaveHullByLen(Geometry geom, double maxLen)
static Geometry
ConstructionFunctions. concaveHullByLenRatio(Geometry geom, double maxLen)
static Geometry
HullFunctions. concaveHullPoints(Geometry geom, double maxLen)
static Geometry
HullFunctions. concaveHullPointsByLenRatio(Geometry geom, double maxLenRatio)
static Geometry
HullFunctions. concaveHullPointsWithHoles(Geometry geom, double maxLen)
static Geometry
HullFunctions. concaveHullPointsWithHolesByLenRatio(Geometry geom, double maxLenRatio)
static Geometry
HullFunctions. concaveHullPolygons(Geometry geom, double maxEdgeLen)
static Geometry
HullFunctions. concaveHullPolygonsByLenRatio(Geometry geom, double maxEdgeLenRatio)
static Geometry
HullFunctions. concaveHullPolygonsTight(Geometry geom, double maxEdgeLen)
static Geometry
HullFunctions. concaveHullPolygonsTightByLenRatio(Geometry geom, double maxEdgeLenRatio)
static Geometry
HullFunctions. concaveHullPolygonsWithHoles(Geometry geom, double maxEdgeLen)
static Geometry
ConstructionFunctions. concaveHullWithHolesByLen(Geometry geom, double maxLen)
static Geometry
ConstructionFunctions. concaveHullWithHolesByLenRatio(Geometry geom, double maxLen)
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
TriangulatePolyFunctions. constrainedDelaunay(Geometry geom)
static Geometry
SelectionNGFunctions. contains(Geometry a, Geometry mask)
static Geometry
ConstructionFunctions. convexHull(Geometry g)
static Geometry
HullFunctions. convexHull(Geometry g)
static Geometry
GeometryFunctions. copy(Geometry g)
static Geometry
SelectionFunctions. coveredBy(Geometry a, Geometry mask)
static Geometry
SelectionFunctions. covers(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. covers(Geometry a, Geometry mask)
static Geometry
SelectionFunctions. coversPrep(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. coversPrep(Geometry a, Geometry mask)
static Geometry
TriangulationFunctions. delaunayEdges(Geometry geom)
static Geometry
TriangulationFunctions. delaunayEdgesWithTolerance(Geometry geom, double tolerance)
static Geometry
TriangulationFunctions. delaunayTriangles(Geometry geom)
static Geometry
TriangulationFunctions. delaunayTrianglesWithTolerance(Geometry geom, double tolerance)
static Geometry
TriangulationFunctions. delaunayTrianglesWithToleranceNoError(Geometry geom, double tolerance)
static Geometry
DistanceFunctions. densifiedDiscreteHausdorffDistanceLine(Geometry a, Geometry b, double frac)
static Geometry
ConstructionFunctions. densify(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. densify(Geometry g, double distance)
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
OverlayNGFunctions. difference(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. difference(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. difference(Geometry a, Geometry b)
static Geometry
OverlayNGSnappingFunctions. difference(Geometry a, Geometry b, double tolerance)
static Geometry
OverlayNGSRFunctions. difference(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. 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
OverlayNGFunctions. differenceBA(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. differenceBA(Geometry a, Geometry b)
static Geometry
OverlayNGSRFunctions. differenceBA(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. differenceBA(Geometry a, Geometry b)
static Geometry
OverlayNoSnapFunctions. differenceBA(Geometry a, Geometry b)
static Geometry
DistanceFunctions. discreteFrechetfDistanceLine(Geometry a, Geometry b)
static Geometry
DistanceFunctions. discreteHausdorffDistanceLine(Geometry a, Geometry b)
static Geometry
DistanceFunctions. discreteOrientedHausdorffDistanceLine(Geometry a, Geometry b)
static Geometry
SelectionFunctions. disjoint(Geometry a, Geometry mask)
static Geometry
DissolveFunctions. dissolve(Geometry geom)
static Geometry
LineHandlingFunctions. dissolve(Geometry geom)
static Geometry
OverlayNGTestFunctions. edgesIntersectionAll(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesIntersectionResult(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesNoded(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesNodedIntersection(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesNodedIntNoOpt(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesOverlayResult(Geometry a)
static Geometry
OverlayNGTestFunctions. edgesUnionAll(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesUnionResult(Geometry a, Geometry b, double scaleFactor)
static Geometry
CreateShapeFunctions. ellipse(Geometry g, int nPts)
static Geometry
CreateShapeFunctions. ellipseRotate(Geometry g, int nPts, double ang)
static Geometry
GeometryFunctions. envelope(Geometry g)
static Geometry
LineHandlingFunctions. extractChains(Geometry g, int maxChainSize)
static Geometry
LinearReferencingFunctions. extractLine(Geometry g, double start, double end)
static Geometry
LineHandlingFunctions. extractLines(Geometry g)
static Geometry
LinearReferencingFunctions. extractPoint(Geometry g, double index)
static Geometry
LineHandlingFunctions. extractSegments(Geometry g)
static Geometry
CoverageFunctions. findGaps(Geometry geom, double gapWidth)
static Geometry
NodingFunctions. findInteriorNodes(Geometry geom)
static Geometry
NodingFunctions. findNodes(Geometry geom)
static Geometry
NodingFunctions. findOneNode(Geometry geom)
static Geometry
SelectionFunctions. firstNComponents(Geometry g, int n)
static Geometry
ValidationFunctions. fixIfInvalid(Geometry geom)
static Geometry
ValidationFunctions. fixInvalid(Geometry geom)
static Geometry
ValidationFunctions. fixInvalidKeepCollapse(Geometry geom)
static Geometry
CreateShapeFunctions. fontGlyph(Geometry g, String text, String fontName)
static Geometry
CreateShapeFunctions. fontGlyphMonospaced(Geometry g, String text)
static Geometry
CreateShapeFunctions. fontGlyphSansSerif(Geometry g, String text)
static Geometry
CreateShapeFunctions. fontGlyphSerif(Geometry g, String text)
static Geometry
CreateShapeFunctions. fontGlyphSerifPointSize(Geometry g, String text, int pointSize)
static Geometry
GeometryFunctions. getCoordinates(Geometry g)
static Geometry
GeometryFunctions. getGeometryN(Geometry g, int i)
static Geometry
GeometryFunctions. getPolygonHoleN(Geometry g, int i)
static Geometry
GeometryFunctions. getPolygonHoles(Geometry geom)
static Geometry
GeometryFunctions. getPolygonShell(Geometry g)
static Geometry
CreateShapeFunctions. grid(Geometry g, int nCells)
static Geometry
CreateShapeFunctions. gridPoints(Geometry g, int nCells)
static Geometry
CreateRandomShapeFunctions. haltonPoints(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. haltonPoints57(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. haltonPointsWithBases(Geometry g, int nPts, int basei, int basej)
static Geometry
CreateFractalShapeFunctions. hilbertCurve(Geometry g, int n)
static Geometry
CreateFractalShapeFunctions. hilbertCurveAtLevel(Geometry g, int level)
static Geometry
SpatialIndexFunctions. hprTreeBounds(Geometry geoms)
static Geometry
SpatialIndexFunctions. hprTreeQuery(Geometry geoms, Geometry queryEnv)
static Geometry
SpatialIndexFunctions. hprTreeQueryCached(Geometry geoms, Geometry queryEnv)
static Geometry
TriangleFunctions. incentre(Geometry g)
static Geometry
UserDataFunctions. index(Geometry g)
static Geometry
SimplificationFunctions. innerPolygonHullByAreaDelta(Geometry geom, double areaFrac)
static Geometry
SimplificationFunctions. innerPolygonHullByVertexFrac(Geometry geom, double vertexFrac)
static Geometry
ConstructionFunctions. interiorPoint(Geometry g)
static Geometry
SelectionFunctions. interiorPointWithin(Geometry a, Geometry mask)
static Geometry
LineSegmentFunctions. intersection(Geometry g1, Geometry g2)
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
OverlayNGFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNGSnappingFunctions. intersection(Geometry a, Geometry b, double tolerance)
static Geometry
OverlayNGSRFunctions. intersection(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNoSnapFunctions. intersection(Geometry a, Geometry b)
static Geometry
LineSegmentFunctions. intersectionDD(Geometry g1, Geometry g2)
static Geometry
OverlayNGTestFunctions. intersectionIsValid(Geometry a, Geometry b)
static Geometry
OverlayNGTestFunctions. intersectionNoOpt(Geometry a, Geometry b)
static Geometry
OverlayNGTestFunctions. intersectionNoValid(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersectionOrigClassic(Geometry a, Geometry b)
Use spatial predicates as a filter in front of intersection.static Geometry
OverlayNGOptFunctions. intersectionOrigPrep(Geometry a, Geometry b)
Use prepared geometry spatial predicates as a filter in front of intersection, with the first operand prepared.static Geometry
OverlayNGOptFunctions. intersectionOrigPrepNoCache(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersectionPrep(Geometry a, Geometry b)
Using auto slows things down quite a bit (due to need to scan to find scale factor), so not recommended.static Geometry
OverlayNGOptFunctions. intersectionPrepNoCache(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersectionPrepSR(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGOptFunctions. intersectionSR(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. intersectionSRNoOpt(Geometry a, Geometry b, double scaleFactor)
static Geometry
SelectionFunctions. intersects(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. intersects(Geometry a, Geometry mask)
static Geometry
SelectionFunctions. intersectsPrep(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. intersectsPrep(Geometry a, Geometry mask)
static Geometry
SelectionFunctions. invalid(Geometry a)
static Geometry
ValidationFunctions. invalidGeoms(Geometry g)
static Geometry
ValidationFunctions. invalidLocations(Geometry g)
Validates all geometries in a collection independently.static Geometry
TriangulatePolyFunctions. joinHoles(Geometry geom)
static Geometry
SpatialIndexFunctions. kdTreeGraph(Geometry geom)
static Geometry
SpatialIndexFunctions. kdTreeGraphSeed(Geometry geom)
static Geometry
SpatialIndexFunctions. kdTreeQuery(Geometry pts, Geometry queryEnv, double tolerance)
static Geometry
SpatialIndexFunctions. kdTreeQueryCached(Geometry pts, Geometry queryEnv, double tolerance)
static Geometry
SpatialIndexFunctions. kdTreeQueryRepeated(Geometry pts, Geometry queryEnv, double tolerance)
static Geometry
SpatialIndexFunctions. kdTreeSplits(Geometry geom)
static Geometry
SpatialIndexFunctions. kdTreeSplitsSeed(Geometry geom)
static Geometry
CreateFractalShapeFunctions. kochSnowflake(Geometry g, int n)
static Geometry
LabellingFunctions. labelPoint(Geometry g)
static Geometry
LabellingFunctions. labelPointConstrained(Geometry g, Geometry con)
static Geometry
ConstructionFunctions. largestEmptyCircle(Geometry obstacles, Geometry boundary, double tolerance)
static Geometry
ConstructionFunctions. largestEmptyCircleCenter(Geometry obstacles, Geometry boundary, double tolerance)
static Geometry
ConstructionFunctions. largestEmptyCircleRadius(Geometry obstacles, Geometry boundary, double tolerance)
static Geometry
UserDataFunctions. length(Geometry g)
static Geometry
SelectionFunctions. lengthGreaterThan(Geometry a, double minLen)
static Geometry
SelectionFunctions. lengthLessThan(Geometry a, double maxLen)
static Geometry
SelectionFunctions. lengthZero(Geometry a)
static Geometry
OverlayNGTestFunctions. limitLine(Geometry line, Geometry box)
static Geometry
LineSegmentFunctions. lineIntersection(Geometry g1, Geometry g2)
static Geometry
LineSegmentFunctions. lineIntersectionDD(Geometry g1, Geometry g2)
static Geometry
LineSegmentFunctions. lineSegmentIntersection(Geometry g1, Geometry g2)
static Geometry
ConversionFunctions. lineToPolygon(Geometry g)
static Geometry
JTSFunctions. logoBuffer(Geometry g, double distance)
static Geometry
JTSFunctions. logoLines(Geometry g)
static Geometry
ConstructionFunctions. maximumDiameter(Geometry g)
static Geometry
ConstructionFunctions. maximumInscribedCircle(Geometry g, double tolerance)
static Geometry
ConstructionFunctions. maximumInscribedCircleCenter(Geometry g, double tolerance)
static Geometry
ConstructionFunctions. maximumInscribedCircleRadius(Geometry g, double tolerance)
static Geometry
NodingFunctions. MCIndexNoding(Geometry geom, Geometry geom2)
static Geometry
NodingFunctions. MCIndexNodingWithPrecision(Geometry geom, Geometry geom2, 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. minimumAreaRectangle(Geometry g)
static Geometry
ConstructionFunctions. minimumBoundingCircle(Geometry g)
static Geometry
ConstructionFunctions. minimumDiameter(Geometry g)
static Geometry
ConstructionFunctions. minimumDiameterRectangle(Geometry g)
static Geometry
SpatialIndexFunctions. monotoneChains(Geometry geom)
static Geometry
CreateFractalShapeFunctions. mortonCurve(Geometry g, int n)
static Geometry
CreateFractalShapeFunctions. mortonCurveAtLevel(Geometry g, int level)
static Geometry
DistanceFunctions. nearestPoints(Geometry a, Geometry b)
static Geometry
DistanceFunctions. nearestPointsIndexed(Geometry a, Geometry b)
static Geometry
DistanceFunctions. nearestPointsIndexedEachB(Geometry a, Geometry b)
static Geometry
CreateShapeFunctions. nGon(Geometry g, int sides)
static Geometry
ValidationFunctions. nonSimpleAllPoints(Geometry geom)
static Geometry
ValidationFunctions. nonSimpleEndpoints(Geometry geom)
static Geometry
ValidationFunctions. nonSimplePoint(Geometry geom)
static Geometry
GeometryFunctions. normalize(Geometry g)
static Geometry
UserDataFunctions. numPoints(Geometry g)
static Geometry
ConstructionFunctions. octagonalEnvelope(Geometry g)
static Geometry
OffsetCurveFunctions. offsetCurve(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. offsetCurveBoth(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. offsetCurveBothWithParams(Geometry geom, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static Geometry
OffsetCurveFunctions. offsetCurveJoined(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. offsetCurveWithParams(Geometry geom, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static Geometry
SimplificationFunctions. outerPolygonHullByAreaDelta(Geometry geom, double areaFrac)
static Geometry
SimplificationFunctions. outerPolygonHullByVertexFrac(Geometry geom, double vertexFrac)
static Geometry
PolygonOverlayFunctions. overlay(Geometry g1, Geometry g2)
static Geometry
PolygonOverlayFunctions. overlayIterSnap(Geometry g1, Geometry g2, double snapTol)
static Geometry
PolygonOverlayFunctions. overlaySR(Geometry g1, Geometry g2, double scale)
static Geometry
TriangleFunctions. perpendicularBisectors(Geometry g)
static Geometry
CreateShapeFunctions. pointFieldCentroidStar(Geometry ptsGeom)
static Geometry
CreateShapeFunctions. pointFieldStar(Geometry ptsGeom, Geometry centrePt)
static Geometry
ConversionFunctions. pointsToLine(Geometry g)
static Geometry
PolygonizeFunctions. polygonize(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeAllErrors(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeCutEdges(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeDangles(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeInvalidRingLines(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeValidPolygonal(Geometry g)
static Geometry
LinearReferencingFunctions. project(Geometry g, Geometry g2)
static Geometry
SpatialIndexFunctions. quadTreeQuery(Geometry geoms, Geometry queryEnv)
static Geometry
CreateRandomShapeFunctions. randomLineString(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPoints(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInGrid(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInGridCircles(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInGridWithGutter(Geometry g, int nPts, double gutterFraction)
static Geometry
CreateRandomShapeFunctions. randomPointsInPolygon(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInTriangle(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomRadialPoints(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomRectilinearWalk(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomSegments(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomSegmentsInGrid(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomSegmentsRectilinear(Geometry g, int nPts)
static Geometry
OffsetCurveFunctions. rawCurve(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. rawCurveWithParams(Geometry geom, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static Geometry
OverlayNGSRFunctions. reducePrecision(Geometry a, double scaleFactor)
static Geometry
PrecisionFunctions. reducePrecision(Geometry geom, double scaleFactor)
static Geometry
PrecisionFunctions. reducePrecisionKeepCollapsed(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
LineSegmentFunctions. reflectPoint(Geometry g1, Geometry g2)
static Geometry
SelectionFunctions. relatePattern(Geometry a, Geometry mask, String pattern)
static Geometry
SelectionNGFunctions. relatePattern(Geometry a, Geometry mask, String pattern)
static Geometry
SelectionNGFunctions. relatePatternPrep(Geometry a, Geometry mask, String pattern)
static Geometry
GeometryFunctions. reverse(Geometry g)
static Geometry
CreateRandomShapeFunctions. robertsPoints(Geometry geom, int nPts)
Creates a set of quasi-random 2D points using the Roberts recurrences.static Geometry
AffineTransformationFunctions. rotate(Geometry g, double angle)
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
AffineTransformationFunctions. scale(Geometry g, double scale)
static Geometry
BufferByUnionFunctions. sectionBuffers(Geometry g, double distance, int maxChainSize)
static Geometry
SelectionFunctions. select(Geometry geom, org.locationtech.jtstest.function.GeometryPredicate pred)
static Geometry
LineHandlingFunctions. sequenceLines(Geometry g)
static Geometry
CreateFractalShapeFunctions. sierpinskiCarpet(Geometry g, int n)
static Geometry
CoverageFunctions. simplify(Geometry coverage, double tolerance)
static Geometry
SimplificationFunctions. simplifyDP(Geometry g, double distance)
static Geometry
CoverageFunctions. simplifyInner(Geometry coverage, double tolerance)
static Geometry
CoverageFunctions. simplifyInOut(Geometry coverage, double toleranceInner, double toleranceOuter)
static Geometry
CoverageFunctions. simplifyOuter(Geometry coverage, double tolerance)
static Geometry
CoverageFunctions. simplifyRemoveRings(Geometry coverage, double tolerance, double factor)
static Geometry
CoverageFunctions. simplifySharp(Geometry coverage, double tolerance, double weight)
static Geometry
CoverageFunctions. simplifyTolerances(Geometry coverage, String tolerancesCSV)
static Geometry
SimplificationFunctions. simplifyTP(Geometry g, double distance)
static Geometry
SimplificationFunctions. simplifyVW(Geometry g, double tolerance)
static Geometry
CreateShapeFunctions. sineStar(Geometry g, int nArms, int nPts)
static Geometry
BufferFunctions. singleSidedBuffer(Geometry geom, double distance)
static Geometry
BufferFunctions. singleSidedBufferCurve(Geometry geom, double distance)
static Geometry
SnappingFunctions. snapAtoB(Geometry g, Geometry g2, double distance)
static Geometry
NodingFunctions. snappingNoder(Geometry geom, Geometry geom2, double snapDistance)
static Geometry
NodingFunctions. snapRoundingNoder(Geometry geom, Geometry geom2, double scaleFactor)
static Geometry
SnappingFunctions. snapToSelfAndClean(Geometry g, double distance)
static Geometry
SortingFunctions. sortByArea(Geometry g)
static Geometry
SortingFunctions. sortByHilbertCode(Geometry g)
static Geometry
SortingFunctions. sortByLength(Geometry g)
static Geometry
SortingFunctions. sortByMinX(Geometry g)
static Geometry
SortingFunctions. sortByMinY(Geometry g)
static Geometry
SortingFunctions. sortByMortonCode(Geometry g)
static Geometry
CreateShapeFunctions. spiral(Geometry geom, int nCycles, int quadrantSegs)
static Geometry
CreateShapeFunctions. squircle(Geometry g, int nPts)
static Geometry
AffineTransformationFunctions. stretchToViewport(Geometry g, Geometry gViewport)
static Geometry
SpatialIndexFunctions. strTreeBounds(Geometry geoms)
static Geometry
SpatialIndexFunctions. strTreeNN(Geometry geoms, Geometry geom)
static Geometry
SpatialIndexFunctions. strTreeNNInSet(Geometry geoms)
static Geometry
SpatialIndexFunctions. strTreeNNk(Geometry geoms, Geometry geom, int k)
static Geometry
SpatialIndexFunctions. strTreeQuery(Geometry geoms, Geometry queryEnv)
static Geometry
SpatialIndexFunctions. strTreeQueryCached(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
OverlayNGFunctions. symDifference(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. symDifference(Geometry a, Geometry b)
static Geometry
OverlayNGSRFunctions. symDifference(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. 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 g1, Geometry g2)
static Geometry
ConversionFunctions. toLines(Geometry g1, Geometry g2)
static Geometry
ConversionFunctions. toMultiPolygon(Geometry g1, Geometry g2)
static Geometry
ConversionFunctions. toPoints(Geometry g1, Geometry g2)
static Geometry
SelectionFunctions. touches(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. touches(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. touchesPrep(Geometry a, Geometry mask)
static Geometry
AffineTransformationFunctions. transformByBaseline(Geometry g, Geometry destBaseline)
static Geometry
AffineTransformationFunctions. transformByVectors(Geometry g, Geometry control)
static Geometry
AffineTransformationFunctions. transformToViewport(Geometry g, Geometry gViewport)
static Geometry
AffineTransformationFunctions. translate(Geometry g, double dx, double dy)
static Geometry
AffineTransformationFunctions. translateCentreToOrigin(Geometry g)
static Geometry
AffineTransformationFunctions. translateToOrigin(Geometry g)
static Geometry
TriangulatePolyFunctions. triangulate(Geometry geom)
static Geometry
OverlayFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGRobustFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGSnappingFunctions. unaryUnion(Geometry a, double tolerance)
static Geometry
OverlayNGSRFunctions. unaryUnion(Geometry a, double scaleFactor)
static Geometry
OverlayNoSnapFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGSnappingFunctions. unaryUnionNoValid(Geometry a, double tolerance)
static Geometry
CoverageFunctions. union(Geometry coverage)
static Geometry
OverlayCommonBitsRemovedFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayEnhancedPrecisionFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNGFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNGSnappingFunctions. union(Geometry a, Geometry b, double tolerance)
static Geometry
OverlayNGSRFunctions. union(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNoSnapFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNGTestFunctions. unionClassicNoderNoValid(Geometry a, Geometry b)
static Geometry
OverlayNGFunctions. unionCoverage(Geometry geom)
static Geometry
OverlayNGTestFunctions. unionIntSymDiff(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. unionIntSymDiffOriginal(Geometry a, Geometry b)
static Geometry
OverlayFunctions. unionUsingGeometryCollection(Geometry a, Geometry b)
static Geometry
SelectionFunctions. valid(Geometry a)
static Geometry
CoverageFunctions. validate(Geometry geom)
static Geometry
CoverageFunctions. validatePolygon(Geometry geom, Geometry adjacentPolys)
static Geometry
CoverageFunctions. validatePolygonWithGaps(Geometry geom, Geometry adjacentPolys, double gapWidth)
static Geometry
CoverageFunctions. validateWithGaps(Geometry geom, double gapWidth)
static Geometry
BufferFunctions. variableBuffer(Geometry line, double startDist, double endDist)
static Geometry
BufferFunctions. variableBufferMid(Geometry line, double startDist, double midDist)
static Geometry
TriangulationFunctions. voronoiDiagram(Geometry sitesGeom, Geometry clipGeom)
static Geometry
TriangulationFunctions. voronoiDiagramWithData(Geometry sitesGeom, Geometry clipGeom)
static Geometry
TriangulationFunctions. voronoiRelaxation(Geometry sitesGeom, Geometry clipGeom, int nIter)
static Geometry
SelectionFunctions. within(Geometry a, Geometry mask)
static Geometry
SelectionFunctions. withinDistance(Geometry a, Geometry mask, double maximumDistance)
static Geometry
SelectionFunctions. withinDistanceIndexed(Geometry a, Geometry mask, double maximumDistance)
Methods in org.locationtech.jtstest.function that return types with arguments of type Geometry Modifier and Type Method Description static List<Geometry>
FunctionsUtil. elements(Geometry g)
Methods in org.locationtech.jtstest.function with parameters of type Geometry Modifier and Type Method Description static Geometry
EditFunctions. addHole(Geometry polyGeom, Geometry hole)
static Geometry
GeometryFunctions. addHoles(Geometry g, Geometry holeGeom)
static Geometry
SelectionNGFunctions. adjacent(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. adjacent(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. adjacent(Geometry a, Geometry b)
static Geometry
SelectionNGFunctions. adjacentPrep(Geometry a, Geometry mask)
static Geometry
HullFunctions. alphaShape(Geometry geom, double alpha)
static Geometry
HullFunctions. alphaShapeWithHoles(Geometry geom, double alpha)
static Geometry
TriangleFunctions. angleBisectors(Geometry g)
static double
GeometryFunctions. area(Geometry g)
static Geometry
UserDataFunctions. area(Geometry g)
static double
OverlayNGRobustFunctions. areaDelta(Geometry a, Geometry b)
Computes the maximum area delta value resulting from identity equations over the overlay operations.static Geometry
SelectionFunctions. areaGreaterThan(Geometry a, double minArea)
static Geometry
SelectionFunctions. areaLessThan(Geometry a, double maxArea)
static Geometry
SelectionFunctions. areaZero(Geometry a)
static Geometry
CreateShapeFunctions. bezierCurve(Geometry geom, double alpha)
static Geometry
CreateShapeFunctions. bezierCurveControl(Geometry geom, Geometry controlPoints)
static Geometry
CreateShapeFunctions. bezierCurveSkew(Geometry geom, double alpha, double skew)
static Geometry
BoundaryFunctions. boundary(Geometry g)
static Geometry
ConstructionFunctions. boundary(Geometry g)
static Geometry
BoundaryFunctions. boundaryEndpoint(Geometry g)
static Geometry
BoundaryFunctions. boundaryMod2(Geometry g)
static Geometry
BoundaryFunctions. boundaryMonoValentEnd(Geometry g)
static Geometry
BoundaryFunctions. boundaryMultiValentEnd(Geometry g)
static Geometry
BufferFunctions. buffer(Geometry g, double distance)
static Geometry
BufferFunctions. bufferAndInverse(Geometry g, double distance)
static Geometry
BufferByUnionFunctions. bufferByComponents(Geometry g, double distance)
static Geometry
BufferByUnionFunctions. bufferBySections(Geometry g, double distance, int maxChainSize)
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. bufferRadius(Geometry radiusLine)
static Geometry
BufferFunctions. bufferValidated(Geometry g, double distance)
static Geometry
BufferFunctions. bufferValidatedGeom(Geometry g, double distance)
static Geometry
BufferFunctions. bufferWithParams(Geometry g, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static Geometry
BufferFunctions. bufferWithSimplify(Geometry g, Double distance, Double simplifyFactor)
static Geometry
FunctionsUtil. buildGeometry(List geoms, Geometry parentGeom)
static Geometry
FunctionsUtil. buildGeometry(Geometry[] geoms)
static Geometry
FunctionsUtil. buildGeometry(Geometry a, Geometry b)
static Geometry
FunctionsUtil. buildGeometryCollection(Geometry[] geoms, Geometry nullGeom)
static Geometry
ConstructionFunctions. centroid(Geometry g)
static Geometry
TriangleFunctions. centroid(Geometry g)
static Geometry
ConstructionFunctions. circleByRadiusLine(Geometry radiusLine, int nPts)
static Geometry
TriangleFunctions. circumcentre(Geometry g)
static Geometry
TriangleFunctions. circumcentreDD(Geometry g)
static Geometry
TriangleFunctions. circumcircle(Geometry g, int quadSegs)
static double
TriangleFunctions. circumradius(Geometry g)
static Geometry
OverlayFunctions. clip(Geometry a, Geometry mask)
static Geometry
OverlayNGTestFunctions. clipRing(Geometry line, Geometry box)
static Geometry
CreateShapeFunctions. comb(Geometry g, int nArms)
static Geometry
BufferByUnionFunctions. componentBuffers(Geometry g, double distance)
static Geometry
HullFunctions. concaveFill(Geometry geom, double maxEdgeLen)
static Geometry
HullFunctions. concaveFillByLenRatio(Geometry geom, double maxEdgeLenRatio)
static Geometry
ConstructionFunctions. concaveHullByLen(Geometry geom, double maxLen)
static Geometry
ConstructionFunctions. concaveHullByLenRatio(Geometry geom, double maxLen)
static double
ConstructionFunctions. concaveHullLenGuess(Geometry geom)
static double
HullFunctions. concaveHullLenGuess(Geometry geom)
static Geometry
HullFunctions. concaveHullPoints(Geometry geom, double maxLen)
static Geometry
HullFunctions. concaveHullPointsByLenRatio(Geometry geom, double maxLenRatio)
static Geometry
HullFunctions. concaveHullPointsWithHoles(Geometry geom, double maxLen)
static Geometry
HullFunctions. concaveHullPointsWithHolesByLenRatio(Geometry geom, double maxLenRatio)
static Geometry
HullFunctions. concaveHullPolygons(Geometry geom, double maxEdgeLen)
static Geometry
HullFunctions. concaveHullPolygonsByLenRatio(Geometry geom, double maxEdgeLenRatio)
static Geometry
HullFunctions. concaveHullPolygonsTight(Geometry geom, double maxEdgeLen)
static Geometry
HullFunctions. concaveHullPolygonsTightByLenRatio(Geometry geom, double maxEdgeLenRatio)
static Geometry
HullFunctions. concaveHullPolygonsWithHoles(Geometry geom, double maxEdgeLen)
static Geometry
ConstructionFunctions. concaveHullWithHolesByLen(Geometry geom, double maxLen)
static Geometry
ConstructionFunctions. concaveHullWithHolesByLenRatio(Geometry geom, double maxLen)
static double
ConstructionFunctions. concaveness(Geometry geom)
A concaveness measure defined in terms of the perimeter length relative to the convex hull perimeter.static double
HullFunctions. concaveness(Geometry geom)
A concaveness measure defined in terms of the perimeter length relative to the convex hull perimeter.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
TriangulatePolyFunctions. constrainedDelaunay(Geometry geom)
static Geometry
SelectionNGFunctions. contains(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. contains(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. contains(Geometry a, Geometry b)
static boolean
SpatialPredicateFunctions. containsProperly(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. containsProperly(Geometry a, Geometry b)
static Geometry
ConstructionFunctions. convexHull(Geometry g)
static Geometry
HullFunctions. convexHull(Geometry g)
static Geometry
GeometryFunctions. copy(Geometry g)
static Geometry
SelectionFunctions. coveredBy(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. coveredBy(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. coveredBy(Geometry a, Geometry b)
static Geometry
SelectionFunctions. covers(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. covers(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. covers(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. covers(Geometry a, Geometry b)
static Geometry
SelectionFunctions. coversPrep(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. coversPrep(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. crosses(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. crosses(Geometry a, Geometry b)
static Geometry
TriangulationFunctions. delaunayEdges(Geometry geom)
static Geometry
TriangulationFunctions. delaunayEdgesWithTolerance(Geometry geom, double tolerance)
static Geometry
TriangulationFunctions. delaunayTriangles(Geometry geom)
static Geometry
TriangulationFunctions. delaunayTrianglesWithTolerance(Geometry geom, double tolerance)
static Geometry
TriangulationFunctions. delaunayTrianglesWithToleranceNoError(Geometry geom, double tolerance)
static Geometry
DistanceFunctions. densifiedDiscreteHausdorffDistanceLine(Geometry a, Geometry b, double frac)
static Geometry
ConstructionFunctions. densify(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. densify(Geometry g, double distance)
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
OverlayNGFunctions. difference(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. difference(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. difference(Geometry a, Geometry b)
static Geometry
OverlayNGSnappingFunctions. difference(Geometry a, Geometry b, double tolerance)
static Geometry
OverlayNGSRFunctions. difference(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. 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
OverlayNGFunctions. differenceBA(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. differenceBA(Geometry a, Geometry b)
static Geometry
OverlayNGSRFunctions. differenceBA(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. differenceBA(Geometry a, Geometry b)
static Geometry
OverlayNoSnapFunctions. differenceBA(Geometry a, Geometry b)
static GeometryCollection
DiffFunctions. diffSegments(Geometry a, Geometry b)
static GeometryCollection
DiffFunctions. diffSegmentsBoth(Geometry a, Geometry b)
static MultiPoint
DiffFunctions. diffVertices(Geometry a, Geometry b)
Diff the vertices in A against B to find vertices in A which are not in B.static GeometryCollection
DiffFunctions. diffVerticesBoth(Geometry a, Geometry b)
static double
DistanceFunctions. discreteFrechetfDistance(Geometry a, Geometry b)
static Geometry
DistanceFunctions. discreteFrechetfDistanceLine(Geometry a, Geometry b)
static double
DistanceFunctions. discreteHausdorffDistance(Geometry a, Geometry b)
static Geometry
DistanceFunctions. discreteHausdorffDistanceLine(Geometry a, Geometry b)
static double
DistanceFunctions. discreteOrientedHausdorffDistance(Geometry a, Geometry b)
static Geometry
DistanceFunctions. discreteOrientedHausdorffDistanceLine(Geometry a, Geometry b)
static Geometry
SelectionFunctions. disjoint(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. disjoint(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. disjoint(Geometry a, Geometry b)
static Geometry
DissolveFunctions. dissolve(Geometry geom)
static Geometry
LineHandlingFunctions. dissolve(Geometry geom)
static double
DistanceFunctions. distance(Geometry a, Geometry b)
static double
DistanceFunctions. distanceIndexed(Geometry a, Geometry b)
static String
WriterFunctions. dumpWKB(Geometry g)
static GeometryCollection
DiffFunctions. duplicateSegments(Geometry a)
static Geometry
OverlayNGTestFunctions. edgesIntersectionAll(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesIntersectionResult(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesNoded(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesNodedIntersection(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesNodedIntNoOpt(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesOverlayResult(Geometry a)
static Geometry
OverlayNGTestFunctions. edgesUnionAll(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. edgesUnionResult(Geometry a, Geometry b, double scaleFactor)
static List<Geometry>
FunctionsUtil. elements(Geometry g)
static Geometry
CreateShapeFunctions. ellipse(Geometry g, int nPts)
static Geometry
CreateShapeFunctions. ellipseRotate(Geometry g, int nPts, double ang)
static Geometry
GeometryFunctions. envelope(Geometry g)
static boolean
SpatialPredicateFunctions. equals(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. equals(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. equalsTopo(Geometry a, Geometry b)
static Geometry
LineHandlingFunctions. extractChains(Geometry g, int maxChainSize)
static Geometry
LinearReferencingFunctions. extractLine(Geometry g, double start, double end)
static Geometry
LineHandlingFunctions. extractLines(Geometry g)
static Geometry
LinearReferencingFunctions. extractPoint(Geometry g, double index)
static Geometry
LineHandlingFunctions. extractSegments(Geometry g)
static Geometry
CoverageFunctions. findGaps(Geometry geom, double gapWidth)
static Geometry
NodingFunctions. findInteriorNodes(Geometry geom)
static Geometry
NodingFunctions. findNodes(Geometry geom)
static Geometry
NodingFunctions. findOneNode(Geometry geom)
static Geometry
SelectionFunctions. firstNComponents(Geometry g, int n)
static Geometry
ValidationFunctions. fixIfInvalid(Geometry geom)
static Geometry
ValidationFunctions. fixInvalid(Geometry geom)
static Geometry
ValidationFunctions. fixInvalidKeepCollapse(Geometry geom)
static Geometry
CreateShapeFunctions. fontGlyph(Geometry g, String text, String fontName)
static Geometry
CreateShapeFunctions. fontGlyphMonospaced(Geometry g, String text)
static Geometry
CreateShapeFunctions. fontGlyphSansSerif(Geometry g, String text)
static Geometry
CreateShapeFunctions. fontGlyphSerif(Geometry g, String text)
static Geometry
CreateShapeFunctions. fontGlyphSerifPointSize(Geometry g, String text, int pointSize)
static Geometry
GeometryFunctions. getCoordinates(Geometry g)
static Envelope
FunctionsUtil. getEnvelopeOrDefault(Geometry g)
static GeometryFactory
FunctionsUtil. getFactoryOrDefault(Geometry g)
static GeometryFactory
FunctionsUtil. getFactoryOrDefault(Geometry g1, Geometry g2)
static Geometry
GeometryFunctions. getGeometryN(Geometry g, int i)
static Geometry
GeometryFunctions. getPolygonHoleN(Geometry g, int i)
static Geometry
GeometryFunctions. getPolygonHoles(Geometry geom)
static Geometry
GeometryFunctions. getPolygonShell(Geometry g)
static Geometry
CreateShapeFunctions. grid(Geometry g, int nCells)
static Geometry
CreateShapeFunctions. gridPoints(Geometry g, int nCells)
static Geometry
CreateRandomShapeFunctions. haltonPoints(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. haltonPoints57(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. haltonPointsWithBases(Geometry g, int nPts, int basei, int basej)
static Geometry
CreateFractalShapeFunctions. hilbertCurve(Geometry g, int n)
static Geometry
CreateFractalShapeFunctions. hilbertCurveAtLevel(Geometry g, int level)
static Geometry
SpatialIndexFunctions. hprTreeBounds(Geometry geoms)
static Geometry
SpatialIndexFunctions. hprTreeQuery(Geometry geoms, Geometry queryEnv)
static Geometry
SpatialIndexFunctions. hprTreeQueryCached(Geometry geoms, Geometry queryEnv)
static Geometry
TriangleFunctions. incentre(Geometry g)
static Geometry
UserDataFunctions. index(Geometry g)
static Geometry
SimplificationFunctions. innerPolygonHullByAreaDelta(Geometry geom, double areaFrac)
static Geometry
SimplificationFunctions. innerPolygonHullByVertexFrac(Geometry geom, double vertexFrac)
static int
NodingFunctions. interiorIntersectionCount(Geometry geom)
static boolean
SpatialPredicateFunctions. interiorIntersects(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. interiorIntersects(Geometry a, Geometry b)
static Geometry
ConstructionFunctions. interiorPoint(Geometry g)
static Geometry
SelectionFunctions. interiorPointWithin(Geometry a, Geometry mask)
static Geometry
LineSegmentFunctions. intersection(Geometry g1, Geometry g2)
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
OverlayNGFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNGSnappingFunctions. intersection(Geometry a, Geometry b, double tolerance)
static Geometry
OverlayNGSRFunctions. intersection(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. intersection(Geometry a, Geometry b)
static Geometry
OverlayNoSnapFunctions. intersection(Geometry a, Geometry b)
static int
NodingFunctions. intersectionCount(Geometry geom)
static Geometry
LineSegmentFunctions. intersectionDD(Geometry g1, Geometry g2)
static Geometry
OverlayNGTestFunctions. intersectionIsValid(Geometry a, Geometry b)
static Geometry
OverlayNGTestFunctions. intersectionNoOpt(Geometry a, Geometry b)
static Geometry
OverlayNGTestFunctions. intersectionNoValid(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersectionOrigClassic(Geometry a, Geometry b)
Use spatial predicates as a filter in front of intersection.static Geometry
OverlayNGOptFunctions. intersectionOrigPrep(Geometry a, Geometry b)
Use prepared geometry spatial predicates as a filter in front of intersection, with the first operand prepared.static Geometry
OverlayNGOptFunctions. intersectionOrigPrepNoCache(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersectionPrep(Geometry a, Geometry b)
Using auto slows things down quite a bit (due to need to scan to find scale factor), so not recommended.static Geometry
OverlayNGOptFunctions. intersectionPrepNoCache(Geometry a, Geometry b)
static Geometry
OverlayNGOptFunctions. intersectionPrepSR(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGOptFunctions. intersectionSR(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. intersectionSRNoOpt(Geometry a, Geometry b, double scaleFactor)
static boolean
LineSegmentFunctions. intersects(Geometry g1, Geometry g2)
static Geometry
SelectionFunctions. intersects(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. intersects(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. intersects(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. intersects(Geometry a, Geometry b)
static Geometry
SelectionFunctions. intersectsPrep(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. intersectsPrep(Geometry a, Geometry mask)
static Geometry
SelectionFunctions. invalid(Geometry a)
static Geometry
ValidationFunctions. invalidGeoms(Geometry g)
static Geometry
ValidationFunctions. invalidLocations(Geometry g)
Validates all geometries in a collection independently.static boolean
OrientationFunctions. isCCW(Geometry g)
static boolean
GeometryFunctions. isClosed(Geometry g)
static boolean
GeometryFunctions. isEmpty(Geometry g)
static boolean
NodingFunctions. isNodingValid(Geometry geom)
static boolean
PointLocationFunctions. isPointInRing(Geometry g1, Geometry g2)
static boolean
GeometryFunctions. isRectangle(Geometry g)
static boolean
NodingFunctions. isSegmentNodingValid(Geometry geom)
static boolean
GeometryFunctions. isSimple(Geometry g)
static boolean
ValidationFunctions. isSimple(Geometry geom)
static boolean
GeometryFunctions. isValid(Geometry g)
static boolean
ValidationFunctions. isValidAllowInvertedRing(Geometry g)
static boolean
DistanceFunctions. isWithinDistance(Geometry a, Geometry b, double dist)
static boolean
DistanceFunctions. isWithinDistanceIndexed(Geometry a, Geometry b, double distance)
static Geometry
TriangulatePolyFunctions. joinHoles(Geometry geom)
static String
JTSFunctions. jtsVersion(Geometry g)
static Geometry
SpatialIndexFunctions. kdTreeGraph(Geometry geom)
static Geometry
SpatialIndexFunctions. kdTreeGraphSeed(Geometry geom)
static Geometry
SpatialIndexFunctions. kdTreeQuery(Geometry pts, Geometry queryEnv, double tolerance)
static Geometry
SpatialIndexFunctions. kdTreeQueryCached(Geometry pts, Geometry queryEnv, double tolerance)
static Geometry
SpatialIndexFunctions. kdTreeQueryRepeated(Geometry pts, Geometry queryEnv, double tolerance)
static Geometry
SpatialIndexFunctions. kdTreeSplits(Geometry geom)
static Geometry
SpatialIndexFunctions. kdTreeSplitsSeed(Geometry geom)
static Geometry
CreateFractalShapeFunctions. kochSnowflake(Geometry g, int n)
static Geometry
LabellingFunctions. labelPoint(Geometry g)
static Geometry
LabellingFunctions. labelPointConstrained(Geometry g, Geometry con)
static Geometry
ConstructionFunctions. largestEmptyCircle(Geometry obstacles, Geometry boundary, double tolerance)
static Geometry
ConstructionFunctions. largestEmptyCircleCenter(Geometry obstacles, Geometry boundary, double tolerance)
static Geometry
ConstructionFunctions. largestEmptyCircleRadius(Geometry obstacles, Geometry boundary, double tolerance)
static double
GeometryFunctions. length(Geometry g)
static Geometry
UserDataFunctions. length(Geometry g)
static Geometry
SelectionFunctions. lengthGreaterThan(Geometry a, double minLen)
static Geometry
SelectionFunctions. lengthLessThan(Geometry a, double maxLen)
static Geometry
SelectionFunctions. lengthZero(Geometry a)
static Geometry
OverlayNGTestFunctions. limitLine(Geometry line, Geometry box)
static Geometry
LineSegmentFunctions. lineIntersection(Geometry g1, Geometry g2)
static Geometry
LineSegmentFunctions. lineIntersectionDD(Geometry g1, Geometry g2)
static Geometry
LineSegmentFunctions. lineSegmentIntersection(Geometry g1, Geometry g2)
static Geometry
ConversionFunctions. lineToPolygon(Geometry g)
static Geometry
JTSFunctions. logoBuffer(Geometry g, double distance)
static Geometry
JTSFunctions. logoLines(Geometry g)
static Geometry
ConstructionFunctions. maximumDiameter(Geometry g)
static double
ConstructionFunctions. maximumDiameterLength(Geometry g)
static Geometry
ConstructionFunctions. maximumInscribedCircle(Geometry g, double tolerance)
static Geometry
ConstructionFunctions. maximumInscribedCircleCenter(Geometry g, double tolerance)
static Geometry
ConstructionFunctions. maximumInscribedCircleRadius(Geometry g, double tolerance)
static double
ConstructionFunctions. maximumInscribedCircleRadiusLen(Geometry g, double tolerance)
static Geometry
NodingFunctions. MCIndexNoding(Geometry geom, Geometry geom2)
static Geometry
NodingFunctions. MCIndexNodingWithPrecision(Geometry geom, Geometry geom2, 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. minimumAreaRectangle(Geometry g)
static Geometry
ConstructionFunctions. minimumBoundingCircle(Geometry g)
static double
ConstructionFunctions. minimumBoundingCircleDiameterLen(Geometry g)
static Geometry
ConstructionFunctions. minimumDiameter(Geometry g)
static double
ConstructionFunctions. minimumDiameterLength(Geometry g)
static Geometry
ConstructionFunctions. minimumDiameterRectangle(Geometry g)
static Geometry
SpatialIndexFunctions. monotoneChains(Geometry geom)
static Geometry
CreateFractalShapeFunctions. mortonCurve(Geometry g, int n)
static Geometry
CreateFractalShapeFunctions. mortonCurveAtLevel(Geometry g, int level)
static Geometry
DistanceFunctions. nearestPoints(Geometry a, Geometry b)
static Geometry
DistanceFunctions. nearestPointsIndexed(Geometry a, Geometry b)
static Geometry
DistanceFunctions. nearestPointsIndexedEachB(Geometry a, Geometry b)
static Geometry
CreateShapeFunctions. nGon(Geometry g, int sides)
static Geometry
ValidationFunctions. nonSimpleAllPoints(Geometry geom)
static Geometry
ValidationFunctions. nonSimpleEndpoints(Geometry geom)
static Geometry
ValidationFunctions. nonSimplePoint(Geometry geom)
static Geometry
GeometryFunctions. normalize(Geometry g)
static Geometry
UserDataFunctions. numPoints(Geometry g)
static Geometry
ConstructionFunctions. octagonalEnvelope(Geometry g)
static Geometry
OffsetCurveFunctions. offsetCurve(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. offsetCurveBoth(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. offsetCurveBothWithParams(Geometry geom, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static Geometry
OffsetCurveFunctions. offsetCurveJoined(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. offsetCurveWithParams(Geometry geom, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static int
OrientationFPFunctions. orientationIndex(Geometry segment, Geometry ptGeom)
static int
OrientationFunctions. orientationIndex(Geometry segment, Geometry ptGeom)
static Geometry
SimplificationFunctions. outerPolygonHullByAreaDelta(Geometry geom, double areaFrac)
static Geometry
SimplificationFunctions. outerPolygonHullByVertexFrac(Geometry geom, double vertexFrac)
static boolean
SpatialPredicateFunctions. overlaps(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. overlaps(Geometry a, Geometry b)
static Geometry
PolygonOverlayFunctions. overlay(Geometry g1, Geometry g2)
static boolean
OverlayNGRobustFunctions. overlayAreaTest(Geometry a, Geometry b)
static Geometry
PolygonOverlayFunctions. overlayIterSnap(Geometry g1, Geometry g2, double snapTol)
static Geometry
PolygonOverlayFunctions. overlaySR(Geometry g1, Geometry g2, double scale)
static Geometry
TriangleFunctions. perpendicularBisectors(Geometry g)
static Geometry
CreateShapeFunctions. pointFieldCentroidStar(Geometry ptsGeom)
static Geometry
CreateShapeFunctions. pointFieldStar(Geometry ptsGeom, Geometry centrePt)
static Geometry
ConversionFunctions. pointsToLine(Geometry g)
static Geometry
PolygonizeFunctions. polygonize(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeAllErrors(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeCutEdges(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeDangles(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeInvalidRingLines(Geometry g)
static Geometry
PolygonizeFunctions. polygonizeValidPolygonal(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
LinearReferencingFunctions. project(Geometry g, Geometry g2)
static double
LinearReferencingFunctions. projectIndex(Geometry g, Geometry g2)
static Geometry
SpatialIndexFunctions. quadTreeQuery(Geometry geoms, Geometry queryEnv)
static Geometry
CreateRandomShapeFunctions. randomLineString(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPoints(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInGrid(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInGridCircles(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInGridWithGutter(Geometry g, int nPts, double gutterFraction)
static Geometry
CreateRandomShapeFunctions. randomPointsInPolygon(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomPointsInTriangle(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomRadialPoints(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomRectilinearWalk(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomSegments(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomSegmentsInGrid(Geometry g, int nPts)
static Geometry
CreateRandomShapeFunctions. randomSegmentsRectilinear(Geometry g, int nPts)
static Geometry
OffsetCurveFunctions. rawCurve(Geometry geom, double distance)
static Geometry
OffsetCurveFunctions. rawCurveWithParams(Geometry geom, Double distance, Integer quadrantSegments, Integer capStyle, Integer joinStyle, Double mitreLimit)
static Geometry
OverlayNGSRFunctions. reducePrecision(Geometry a, double scaleFactor)
static Geometry
PrecisionFunctions. reducePrecision(Geometry geom, double scaleFactor)
static Geometry
PrecisionFunctions. reducePrecisionKeepCollapsed(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
LineSegmentFunctions. reflectPoint(Geometry g1, Geometry g2)
static boolean
SpatialPredicateFunctions. relate(Geometry a, Geometry b, String mask)
static boolean
SpatialPredicateNGFunctions. relate(Geometry a, Geometry b, String mask)
static String
SpatialPredicateFunctions. relateEndpoint(Geometry a, Geometry b)
static String
SpatialPredicateNGFunctions. relateEndpoint(Geometry a, Geometry b)
static String
SpatialPredicateFunctions. relateMatrix(Geometry a, Geometry b)
static String
SpatialPredicateNGFunctions. relateMatrix(Geometry a, Geometry b)
static String
SpatialPredicateFunctions. relateMonoValent(Geometry a, Geometry b)
static String
SpatialPredicateNGFunctions. relateMonoValent(Geometry a, Geometry b)
static String
SpatialPredicateFunctions. relateMultiValent(Geometry a, Geometry b)
static String
SpatialPredicateNGFunctions. relateMultiValent(Geometry a, Geometry b)
static Geometry
SelectionFunctions. relatePattern(Geometry a, Geometry mask, String pattern)
static Geometry
SelectionNGFunctions. relatePattern(Geometry a, Geometry mask, String pattern)
static Geometry
SelectionNGFunctions. relatePatternPrep(Geometry a, Geometry mask, String pattern)
static Geometry
GeometryFunctions. reverse(Geometry g)
static Geometry
CreateRandomShapeFunctions. robertsPoints(Geometry geom, int nPts)
Creates a set of quasi-random 2D points using the Roberts recurrences.static Geometry
AffineTransformationFunctions. rotate(Geometry g, double angle)
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
AffineTransformationFunctions. scale(Geometry g, double scale)
static Geometry
BufferByUnionFunctions. sectionBuffers(Geometry g, double distance, int maxChainSize)
static Geometry
SelectionFunctions. select(Geometry geom, org.locationtech.jtstest.function.GeometryPredicate pred)
static Geometry
LineHandlingFunctions. sequenceLines(Geometry g)
static void
FunctionsUtil. showIndicator(Geometry geom)
static void
FunctionsUtil. showIndicator(Geometry geom, Color lineClr)
static Geometry
CreateFractalShapeFunctions. sierpinskiCarpet(Geometry g, int n)
static Geometry
CoverageFunctions. simplify(Geometry coverage, double tolerance)
static Geometry
SimplificationFunctions. simplifyDP(Geometry g, double distance)
static Geometry
CoverageFunctions. simplifyInner(Geometry coverage, double tolerance)
static Geometry
CoverageFunctions. simplifyInOut(Geometry coverage, double toleranceInner, double toleranceOuter)
static Geometry
CoverageFunctions. simplifyOuter(Geometry coverage, double tolerance)
static Geometry
CoverageFunctions. simplifyRemoveRings(Geometry coverage, double tolerance, double factor)
static Geometry
CoverageFunctions. simplifySharp(Geometry coverage, double tolerance, double weight)
static Geometry
CoverageFunctions. simplifyTolerances(Geometry coverage, String tolerancesCSV)
static Geometry
SimplificationFunctions. simplifyTP(Geometry g, double distance)
static Geometry
SimplificationFunctions. simplifyVW(Geometry g, double tolerance)
static Geometry
CreateShapeFunctions. sineStar(Geometry g, int nArms, int nPts)
static GeometryCollection
DiffFunctions. singleSegments(Geometry a)
static Geometry
BufferFunctions. singleSidedBuffer(Geometry geom, double distance)
static Geometry
BufferFunctions. singleSidedBufferCurve(Geometry geom, double distance)
static Geometry
SnappingFunctions. snapAtoB(Geometry g, Geometry g2, double distance)
static Geometry
NodingFunctions. snappingNoder(Geometry geom, Geometry geom2, double snapDistance)
static Geometry
NodingFunctions. snapRoundingNoder(Geometry geom, Geometry geom2, double scaleFactor)
static Geometry
SnappingFunctions. snapToSelfAndClean(Geometry g, double distance)
static Geometry
SortingFunctions. sortByArea(Geometry g)
static Geometry
SortingFunctions. sortByHilbertCode(Geometry g)
static Geometry
SortingFunctions. sortByLength(Geometry g)
static Geometry
SortingFunctions. sortByMinX(Geometry g)
static Geometry
SortingFunctions. sortByMinY(Geometry g)
static Geometry
SortingFunctions. sortByMortonCode(Geometry g)
static Geometry
CreateShapeFunctions. spiral(Geometry geom, int nCycles, int quadrantSegs)
static Geometry
CreateShapeFunctions. squircle(Geometry g, int nPts)
static double
GeometryFunctions. SRID(Geometry g)
static Geometry
AffineTransformationFunctions. stretchToViewport(Geometry g, Geometry gViewport)
static Geometry
SpatialIndexFunctions. strTreeBounds(Geometry geoms)
static Geometry
SpatialIndexFunctions. strTreeNN(Geometry geoms, Geometry geom)
static Geometry
SpatialIndexFunctions. strTreeNNInSet(Geometry geoms)
static Geometry
SpatialIndexFunctions. strTreeNNk(Geometry geoms, Geometry geom, int k)
static Geometry
SpatialIndexFunctions. strTreeQuery(Geometry geoms, Geometry queryEnv)
static Geometry
SpatialIndexFunctions. strTreeQueryCached(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
OverlayNGFunctions. symDifference(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. symDifference(Geometry a, Geometry b)
static Geometry
OverlayNGSRFunctions. symDifference(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. 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 g1, Geometry g2)
static Geometry
ConversionFunctions. toLines(Geometry g1, Geometry g2)
static Geometry
ConversionFunctions. toMultiPolygon(Geometry g1, Geometry g2)
static Geometry
ConversionFunctions. toPoints(Geometry g1, Geometry g2)
static Geometry
SelectionFunctions. touches(Geometry a, Geometry mask)
static Geometry
SelectionNGFunctions. touches(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. touches(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. touches(Geometry a, Geometry b)
static Geometry
SelectionNGFunctions. touchesPrep(Geometry a, Geometry mask)
static Geometry
AffineTransformationFunctions. transformByBaseline(Geometry g, Geometry destBaseline)
static Geometry
AffineTransformationFunctions. transformByVectors(Geometry g, Geometry control)
static Geometry
AffineTransformationFunctions. transformToViewport(Geometry g, Geometry gViewport)
static Geometry
AffineTransformationFunctions. translate(Geometry g, double dx, double dy)
static Geometry
AffineTransformationFunctions. translateCentreToOrigin(Geometry g)
static Geometry
AffineTransformationFunctions. translateToOrigin(Geometry g)
static Geometry
TriangulatePolyFunctions. triangulate(Geometry geom)
static Geometry
OverlayFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGRobustFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGSnappingFunctions. unaryUnion(Geometry a, double tolerance)
static Geometry
OverlayNGSRFunctions. unaryUnion(Geometry a, double scaleFactor)
static Geometry
OverlayNoSnapFunctions. unaryUnion(Geometry a)
static Geometry
OverlayNGSnappingFunctions. unaryUnionNoValid(Geometry a, double tolerance)
static Geometry
CoverageFunctions. union(Geometry coverage)
static Geometry
OverlayCommonBitsRemovedFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayEnhancedPrecisionFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNGFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNGRobustFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNGSnappingFunctions. union(Geometry a, Geometry b, double tolerance)
static Geometry
OverlayNGSRFunctions. union(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGStrictFunctions. union(Geometry a, Geometry b)
static Geometry
OverlayNoSnapFunctions. union(Geometry a, Geometry b)
static double
OverlayNGRobustFunctions. unionArea(Geometry a)
static Geometry
OverlayNGTestFunctions. unionClassicNoderNoValid(Geometry a, Geometry b)
static Geometry
OverlayNGFunctions. unionCoverage(Geometry geom)
static Geometry
OverlayNGTestFunctions. unionIntSymDiff(Geometry a, Geometry b, double scaleFactor)
static Geometry
OverlayNGTestFunctions. unionIntSymDiffOriginal(Geometry a, Geometry b)
static double
OverlayNGRobustFunctions. unionLength(Geometry a)
static Geometry
OverlayFunctions. unionUsingGeometryCollection(Geometry a, Geometry b)
static Geometry
SelectionFunctions. valid(Geometry a)
static Geometry
CoverageFunctions. validate(Geometry geom)
static Geometry
CoverageFunctions. validatePolygon(Geometry geom, Geometry adjacentPolys)
static Geometry
CoverageFunctions. validatePolygonWithGaps(Geometry geom, Geometry adjacentPolys, double gapWidth)
static Geometry
CoverageFunctions. validateWithGaps(Geometry geom, double gapWidth)
static Geometry
BufferFunctions. variableBuffer(Geometry line, double startDist, double endDist)
static Geometry
BufferFunctions. variableBufferMid(Geometry line, double startDist, double midDist)
static Geometry
TriangulationFunctions. voronoiDiagram(Geometry sitesGeom, Geometry clipGeom)
static Geometry
TriangulationFunctions. voronoiDiagramWithData(Geometry sitesGeom, Geometry clipGeom)
static Geometry
TriangulationFunctions. voronoiRelaxation(Geometry sitesGeom, Geometry clipGeom, int nIter)
static Geometry
SelectionFunctions. within(Geometry a, Geometry mask)
static boolean
SpatialPredicateFunctions. within(Geometry a, Geometry b)
static boolean
SpatialPredicateNGFunctions. within(Geometry a, Geometry b)
static Geometry
SelectionFunctions. withinDistance(Geometry a, Geometry mask, double maximumDistance)
static Geometry
SelectionFunctions. withinDistanceIndexed(Geometry a, Geometry mask, double maximumDistance)
static String
WriterFunctions. writeGeoJSON(Geometry g)
static String
WriterFunctions. writeGeoJSONFixDecimal(Geometry g, int numDecimals)
static String
WriterFunctions. writeGML(Geometry geom)
static String
WriterFunctions. writeKML(Geometry geom)
static String
WriterFunctions. writeOra(Geometry g)
static String
WriterFunctions. writeSVG(Geometry a, Geometry b)
static String
WriterFunctions. writeWKB(Geometry g)
-
Uses of Geometry in org.locationtech.jtstest.geomfunction
Methods in org.locationtech.jtstest.geomfunction with parameters of type Geometry Modifier and Type Method Description abstract Object
BaseGeometryFunction. invoke(Geometry geom, Object[] args)
Object
FilterGeometryFunction. invoke(Geometry geom, Object[] args)
Object
GeometryFunction. invoke(Geometry geom, Object[] args)
Invokes this function.Object
RepeaterGeometryFunction. invoke(Geometry geom, Object[] args)
Object
SpreaderGeometryFunction. invoke(Geometry geom, Object[] args)
Object
StaticMethodGeometryFunction. invoke(Geometry g, Object[] arg)
Constructors in org.locationtech.jtstest.geomfunction with parameters of type Geometry Constructor Description GeometryFunctionInvocation(GeometryFunction function, Geometry target, Object[] args)
-
Uses of Geometry in org.locationtech.jtstest.geomop
Methods in org.locationtech.jtstest.geomop that return Geometry Modifier and Type Method Description static Geometry
TestCaseGeometryFunctions. bufferMitredJoin(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. densify(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. differenceNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. differenceSR(Geometry geom0, Geometry geom1, double scale)
static Geometry
TestCaseGeometryFunctions. intersectionNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. intersectionSR(Geometry geom0, Geometry geom1, double scale)
static Geometry
OverlayValidatedGeometryOperation. invokeGeometryOverlayMethod(int opCode, Geometry g0, Geometry g1)
static Geometry
TestCaseGeometryFunctions. minClearanceLine(Geometry g)
static Geometry
TestCaseGeometryFunctions. polygonize(Geometry g)
static Geometry
TestCaseGeometryFunctions. polygonizeValidPolygonal(Geometry g)
static Geometry
TestCaseGeometryFunctions. reducePrecision(Geometry g, double scaleFactor)
static Geometry
TestCaseGeometryFunctions. simplifyDP(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. simplifyTP(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. symDifferenceNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. symDifferenceSR(Geometry geom0, Geometry geom1, double scale)
static Geometry
TestCaseGeometryFunctions. unionNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. unionSr(Geometry geom0, Geometry geom1, double scale)
Methods in org.locationtech.jtstest.geomop with parameters of type Geometry Modifier and Type Method Description static double
OverlayValidatedGeometryOperation. areaDiff(Geometry g0, Geometry g1)
static Geometry
TestCaseGeometryFunctions. bufferMitredJoin(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. densify(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. differenceNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. differenceSR(Geometry geom0, Geometry geom1, double scale)
static Geometry
TestCaseGeometryFunctions. intersectionNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. intersectionSR(Geometry geom0, Geometry geom1, double scale)
abstract Object
BaseGeometryFunction. invoke(Geometry geom, Object[] args)
Result
BufferValidatedGeometryOperation. invoke(String opName, Geometry geometry, Object[] args)
Invokes the named operationObject
GeometryFunction. invoke(Geometry geom, Object[] args)
Invokes this function.Result
GeometryFunctionOperation. invoke(String opName, Geometry geometry, Object[] args)
Result
GeometryMethodOperation. invoke(String opName, Geometry geometry, Object[] args)
Result
GeometryOperation. invoke(String opName, Geometry geometry, Object[] args)
Invokes an operation on aGeometry
.Result
LoggingGeometryOperation. invoke(String opName, Geometry geometry, Object[] args)
Result
OverlayValidatedGeometryOperation. invoke(String opName, Geometry geometry, Object[] args)
Invokes the named operationResult
PreparedGeometryOperation. invoke(String opName, Geometry geometry, Object[] args)
Invokes the named operationObject
StaticMethodGeometryFunction. invoke(Geometry g, Object[] arg)
Result
TeeGeometryOperation. invoke(String opName, Geometry geometry, Object[] args)
Invokes the named operationstatic Geometry
OverlayValidatedGeometryOperation. invokeGeometryOverlayMethod(int opCode, Geometry g0, Geometry g1)
Result
OverlayValidatedGeometryOperation. invokeValidatedOverlayOp(int opCode, Geometry g0, Object[] args)
Invokes an overlay op, optionally using snapping, and optionally validating the result.boolean
GeometryMatcher. match(Geometry a, Geometry b)
boolean
NormalizedGeometryMatcher. match(Geometry a, Geometry b)
static double
TestCaseGeometryFunctions. minClearance(Geometry g)
static Geometry
TestCaseGeometryFunctions. minClearanceLine(Geometry g)
static boolean
TestCaseGeometryFunctions. overlayAreaTest(Geometry a, Geometry b)
static Geometry
TestCaseGeometryFunctions. polygonize(Geometry g)
static Geometry
TestCaseGeometryFunctions. polygonizeValidPolygonal(Geometry g)
static Geometry
TestCaseGeometryFunctions. reducePrecision(Geometry g, double scaleFactor)
protected void
PreparedGeometryTeeOperation. runTeeOp(String opName, Geometry geometry, Object[] args)
protected abstract void
TeeGeometryOperation. runTeeOp(String opName, Geometry geometry, Object[] args)
static Geometry
TestCaseGeometryFunctions. simplifyDP(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. simplifyTP(Geometry g, double distance)
static Geometry
TestCaseGeometryFunctions. symDifferenceNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. symDifferenceSR(Geometry geom0, Geometry geom1, double scale)
static double
TestCaseGeometryFunctions. unionArea(Geometry geom)
static double
TestCaseGeometryFunctions. unionLength(Geometry geom)
static Geometry
TestCaseGeometryFunctions. unionNG(Geometry geom0, Geometry geom1)
static Geometry
TestCaseGeometryFunctions. unionSr(Geometry geom0, Geometry geom1, double scale)
-
Uses of Geometry in org.locationtech.jtstest.test
Methods in org.locationtech.jtstest.test that return Geometry Modifier and Type Method Description Geometry
TestCase. getExpectedBoundary()
Geometry
TestCase. getExpectedConvexHull()
Geometry
TestCase. getExpectedDifference()
Geometry
TestCase. getExpectedIntersection()
Geometry
TestCase. getExpectedSymDifference()
Geometry
TestCase. getExpectedUnion()
Geometry[]
TestCase. getGeometries()
Geometry
Testable. getGeometry(int index)
Geometry
TestCase. getGeometry(int index)
Methods in org.locationtech.jtstest.test with parameters of type Geometry Modifier and Type Method Description void
TestCase. setExpectedBoundary(Geometry expectedBoundary)
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
Methods in org.locationtech.jtstest.testbuilder that return Geometry Modifier and Type Method Description Geometry
GeometryTreePanel. getSelectedGeometry()
Gets currently selected geometry, if any.Methods in org.locationtech.jtstest.testbuilder with parameters of type Geometry Modifier and Type Method Description void
GeometryEditPanel. draw(Geometry geom, Color lineClr, Color fillClr)
void
GeometryEditPanel. flash(Geometry g)
void
JTSTestBuilderFrame. inspectGeometry(String tag, Geometry geometry)
static void
TestBuilderDialogs. inspectGeometry(JTSTestBuilderFrame tbFrame, int geomIndex, Geometry geometry)
void
GeometryTreePanel. populate(Geometry geom, int source)
void
GeometryTreePanel. populate(Geometry geom, int source, Comparator comp)
void
GeometryInspectorDialog. setGeometry(int geomIndex, Geometry geometry)
void
InspectorPanel. setGeometry(String tag, Geometry geom, int source, boolean isEditable)
void
WKTPanel. setText(Geometry g, int geomIndex)
void
GeometryEditPanel. zoom(Geometry geom)
Constructors in org.locationtech.jtstest.testbuilder with parameters of type Geometry Constructor Description GeometryTreeModel(Geometry geom, int source, Comparator comp)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.controller
Methods in org.locationtech.jtstest.testbuilder.controller that return Geometry Modifier and Type Method Description Geometry
JTSTestBuilderController. getGeometryA()
Geometry
JTSTestBuilderController. getGeometryB()
Methods in org.locationtech.jtstest.testbuilder.controller with parameters of type Geometry Modifier and Type Method Description void
JTSTestBuilderController. addTestCase(Geometry[] geom, String name)
void
JTSTestBuilderController. extractComponentsToTestCase(Geometry aoi, boolean isSegments)
void
JTSTestBuilderController. flash(Geometry geom)
void
JTSTestBuilderController. indicatorShow(Geometry geom, Color lineClr)
void
JTSTestBuilderController. inspectGeometry(String tag, Geometry geometry)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.geom
Methods in org.locationtech.jtstest.testbuilder.geom that return Geometry Modifier and Type Method Description Geometry
GeometryCombiner. addLineString(Geometry orig, Coordinate[] pts)
Geometry
GeometryCombiner. addPoint(Geometry orig, Coordinate pt)
Geometry
GeometryCombiner. addPolygonRing(Geometry orig, Coordinate[] pts)
Geometry
GeometryCombiner. combine(Geometry orig, Geometry geom)
Geometry
GeometryLocation. delete()
static Geometry
GeometryVertexDeleter. delete(Geometry geom, LineString line, int vertexIndex)
static Geometry
GeometryComponentDeleter. deleteComponent(Geometry geom, Geometry component)
static Geometry
GeometryBoxDeleter. deleteComponents(Geometry geom, Envelope env, boolean deleteIntersecting)
static Geometry
GeometryBoxDeleter. deleteComponentsAndVertices(Geometry geom, Envelope env)
static Geometry
GeometryBoxDeleter. deleteComponentsAndVertices(Geometry geom, Envelope env, boolean deleteIntersectingComponents)
static Geometry
GeometryBoxDeleter. deleteVertices(Geometry geom, Envelope env)
static Geometry
SegmentExtracter. extract(Geometry geom, Geometry aoi)
Geometry
GeometryLocation. getComponent()
Geometry
SegmentExtracter.SegmentExtracterFilter. getGeometry(GeometryFactory factory)
Geometry
GeometryLocation. insert()
static Geometry
GeometryVertexInserter. insert(Geometry geom, LineString line, int segIndex, Coordinate newVertex)
static Geometry
GeometryVertexMover. move(Geometry geom, Coordinate fromLoc, Coordinate toLoc)
static Geometry
GeometryCombiner. replace(Geometry parent, Geometry original, Geometry replacement)
static Geometry
GeometryComponentTransformer. transform(Geometry geom, Geometry component, AffineTransformation trans)
static Geometry
GeometryComponentTransformer. transform(Geometry geom, AffineTransformation trans)
Methods in org.locationtech.jtstest.testbuilder.geom with parameters of type Geometry Modifier and Type Method Description Geometry
GeometryCombiner. addLineString(Geometry orig, Coordinate[] pts)
Geometry
GeometryCombiner. addPoint(Geometry orig, Coordinate pt)
Geometry
GeometryCombiner. addPolygonRing(Geometry orig, Coordinate[] pts)
static double
GeometryUtil. area(Geometry geom)
Geometry
GeometryCombiner. combine(Geometry orig, Geometry geom)
static Geometry
GeometryVertexDeleter. delete(Geometry geom, LineString line, int vertexIndex)
static Geometry
GeometryComponentDeleter. deleteComponent(Geometry geom, Geometry component)
static Geometry
GeometryBoxDeleter. deleteComponents(Geometry geom, Envelope env, boolean deleteIntersecting)
static Geometry
GeometryBoxDeleter. deleteComponentsAndVertices(Geometry geom, Envelope env)
static Geometry
GeometryBoxDeleter. deleteComponentsAndVertices(Geometry geom, Envelope env, boolean deleteIntersectingComponents)
static Geometry
GeometryBoxDeleter. deleteVertices(Geometry geom, Envelope env)
static Geometry
SegmentExtracter. extract(Geometry geom, Geometry aoi)
static List
GeometryCombiner. extractElements(Geometry geom, boolean skipEmpty)
static Coordinate
NearestPointFinder. findNearestPoint(Geometry geom, Coordinate pt, double tolerance)
static Coordinate[]
AdjacentVertexFinder. findVertices(Geometry geom, Coordinate testPt)
List<GeometryLocation>
ComponentLocater. getComponents(Geometry aoi)
static List<GeometryLocation>
ComponentLocater. getComponents(Geometry parentGeom, Coordinate queryPt, double tolerance)
static Coordinate
ConstrainedInteriorPoint. getCoordinate(Polygon poly, Geometry constraint)
static boolean
GeometryUtil. hasArea(Geometry geom)
static boolean
GeometryUtil. hasLength(Geometry geom)
static Geometry
GeometryVertexInserter. insert(Geometry geom, LineString line, int segIndex, Coordinate newVertex)
static GeometryLocation
GeometryPointLocater. locate(Geometry geom, Coordinate testPt, double tolerance)
static GeometryLocation
GeometryPointLocater. locateNonVertexPoint(Geometry geom, Coordinate testPt, double tolerance)
static GeometryLocation
GeometryPointLocater. locateVertex(Geometry geom, Coordinate testPt, double tolerance)
static Coordinate
VertexLocater. locateVertex(Geometry geom, Coordinate testPt, double tolerance)
static String
GeometryUtil. metricsSummary(Geometry g)
static Geometry
GeometryVertexMover. move(Geometry geom, Coordinate fromLoc, Coordinate toLoc)
static Geometry
GeometryCombiner. replace(Geometry parent, Geometry original, Geometry replacement)
static String
GeometryUtil. structureSummary(Geometry g)
static Envelope
GeometryUtil. totalEnvelope(Geometry geom)
Gets the envelope including all holes which might lie outside a polygon.static Geometry
GeometryComponentTransformer. transform(Geometry geom, Geometry component, AffineTransformation trans)
static Geometry
GeometryComponentTransformer. transform(Geometry geom, AffineTransformation trans)
Constructors in org.locationtech.jtstest.testbuilder.geom with parameters of type Geometry Constructor Description AdjacentVertexFinder(Geometry geom)
ComponentLocater(Geometry parentGeom)
FacetLocater(Geometry parentGeom)
GeometryLocation(Geometry parent, Geometry component, int[] componentPath)
GeometryLocation(Geometry parent, Geometry component, int[] componentPath, int segmentIndex, boolean isVertex, Coordinate pt)
GeometryLocation(Geometry parent, Geometry component, int segmentIndex, boolean isVertex, Coordinate pt)
GeometryLocation(Geometry parent, Geometry component, int index, Coordinate pt)
GeometryPointLocater(Geometry geom)
NearestPointFinder(Geometry geom)
VertexLocater(Geometry geom)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.io
Methods in org.locationtech.jtstest.testbuilder.io with parameters of type Geometry Modifier and Type Method Description String
XMLTestWriter. getTestXML(Geometry geometry, String opName, String[] arguments, boolean useWKT)
static String
IOUtil. toGML(Geometry g)
static String
IOUtil. toWKBHex(Geometry g)
static String
IOUtil. toWKT(Geometry g, boolean isFormatted)
String
HtmlSvgTestWriter. write(Geometry ga, Geometry gb, String name, String description)
String
SVGTestWriter. write(Geometry ga, Geometry gb, String name, String description)
static String
SVGTestWriter. writeSVG(Geometry ga, Geometry gb)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.io.shapefile
Methods in org.locationtech.jtstest.testbuilder.io.shapefile that return Geometry Modifier and Type Method Description Geometry
Shapefile. next()
Returns the next geometry in the shapefile streamGeometry
MultiLineHandler. read(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength)
Geometry
MultiPointHandler. read(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength)
Geometry
PointHandler. read(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength)
Geometry
PolygonHandler. read(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength)
Geometry
ShapeHandler. read(EndianDataInputStream file, GeometryFactory geometryFactory, int contentLength)
Methods in org.locationtech.jtstest.testbuilder.io.shapefile with parameters of type Geometry Modifier and Type Method Description int
MultiLineHandler. getLength(Geometry geometry)
int
MultiPointHandler. getLength(Geometry geometry)
Calcuates the record length of this object.int
PointHandler. getLength(Geometry geometry)
Calcuates the record length of this object.int
PolygonHandler. getLength(Geometry geometry)
int
ShapeHandler. getLength(Geometry geometry)
static ShapeHandler
Shapefile. getShapeHandler(Geometry geom, int ShapeFileDimentions)
static int
Shapefile. getShapeType(Geometry geom, int coordDimension)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.model
Methods in org.locationtech.jtstest.testbuilder.model that return Geometry Modifier and Type Method Description Geometry
LayerList. getComponent(Coordinate pt, double tolerance)
Geometry[]
LayerList. getComponents(Geometry aoi, boolean isSegments)
Geometry
TestRunnerTestCaseAdapter. getExpectedBoundary()
Geometry
TestRunnerTestCaseAdapter. getExpectedConvexHull()
Geometry
TestRunnerTestCaseAdapter. getExpectedDifference()
Geometry
TestRunnerTestCaseAdapter. getExpectedIntersection()
Geometry
TestRunnerTestCaseAdapter. getExpectedSymDifference()
Geometry
TestRunnerTestCaseAdapter. getExpectedUnion()
Geometry[]
TestCaseEdit. getGeometries()
Geometry
GeometryContainer. getGeometry()
Geometry
GeometryEditModel. getGeometry()
Geometry
GeometryEditModel. getGeometry(int i)
Geometry
IndexedGeometryContainer. getGeometry()
Geometry
Layer. getGeometry()
Geometry
ListGeometryContainer. getGeometry()
Geometry
ResultGeometryContainer. getGeometry()
Geometry
StaticGeometryContainer. getGeometry()
Geometry
TestCaseEdit. getGeometry(int i)
Geometry
TestRunnerTestCaseAdapter. getGeometry(int index)
Geometry
GeometryEditModel. getResult()
Geometry
TestCaseEdit. getResult()
Geometry
GeometryStretcherView. getStretchedGeometry(int index)
Geometry
UndoBuffer. peek()
Geometry
UndoBuffer. pop()
Geometry
TestBuilderModel. readGeometryFromClipboard()
Geometry
TestRunnerTestCaseAdapter. toGeometry(Test test)
Methods in org.locationtech.jtstest.testbuilder.model with parameters of type Geometry Modifier and Type Method Description void
ListGeometryContainer. add(Geometry geom)
void
TestBuilderModel. addCase(Geometry[] geoms)
void
TestBuilderModel. addCase(Geometry[] geoms, String name)
void
TestBuilderModel. addIndicator(Geometry geom)
Geometry[]
LayerList. getComponents(Geometry aoi, boolean isSegments)
String
TestBuilderModel. getResultDisplayString(Geometry g)
static String
GeometryEditModel. getText(Geometry geom, int textType)
void
UndoBuffer. pop(Geometry geometry)
Pops the buffer if the top geometry is teh same as the given geometry.void
UndoBuffer. save(Geometry g)
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)
void
TestRunnerTestCaseAdapter. setExpectedSymDifference(Geometry expectedSymDifference)
void
TestRunnerTestCaseAdapter. setExpectedUnion(Geometry expectedUnion)
void
GeometryEditModel. setGeometry(int i, Geometry g)
void
GeometryEditModel. setGeometry(Geometry g)
void
Layer. setGeometry(Geometry geom)
void
StaticGeometryContainer. setGeometry(Geometry geom)
void
TestCaseEdit. setGeometry(int i, Geometry geom)
void
TestRunnerTestCaseAdapter. setGeometry(int index, Geometry g)
void
TestCaseEdit. setResult(Geometry geom)
static String
GeometryEditModel. toStringVeryLarge(Geometry g)
Constructors in org.locationtech.jtstest.testbuilder.model with parameters of type Geometry Constructor Description StaticGeometryContainer(Geometry geometry)
TestCaseEdit(Geometry[] geom)
TestCaseEdit(Geometry[] geom, String name)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.topostretch
Methods in org.locationtech.jtstest.testbuilder.topostretch that return Geometry Modifier and Type Method Description Geometry
GeometryVerticesMover. move()
static Geometry
GeometryVerticesMover. move(Geometry geom, Map moves)
Geometry[]
TopologyStretcher. stretch(double nearnessTol, double stretchDistance)
Geometry[]
TopologyStretcher. stretch(double nearnessTol, double stretchDistance, Envelope mask)
Methods in org.locationtech.jtstest.testbuilder.topostretch with parameters of type Geometry Modifier and Type Method Description static Geometry
GeometryVerticesMover. move(Geometry geom, Map moves)
Constructors in org.locationtech.jtstest.testbuilder.topostretch with parameters of type Geometry Constructor Description GeometryVerticesMover(Geometry geom, Map moves)
TopologyStretcher(Geometry g)
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 Geometry Modifier and Type Method Description String
GeometryLocationsWriter. OLDwriteLocation(Geometry geom, Coordinate p, double tolerance)
String
GeometryLocationsWriter. writeComponentLocation(Geometry geom, Coordinate p, double tolerance)
String
GeometryLocationsWriter. writeFacetLocation(Geometry geom, Coordinate p, double tolerance)
Constructors in org.locationtech.jtstest.testbuilder.ui with parameters of type Geometry Constructor Description GeometryTransferable(Geometry geom)
GeometryTransferable(Geometry geom, boolean isFormatted)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.ui.render
Fields in org.locationtech.jtstest.testbuilder.ui.render declared as Geometry Modifier and Type Field Description static Geometry
OperationMonitorManager. indicator
Methods in org.locationtech.jtstest.testbuilder.ui.render with parameters of type Geometry Modifier and Type Method Description static void
GeometryPainter. paint(Graphics2D g, Viewport viewport, Geometry geometry, Style style)
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)
-
Uses of Geometry in org.locationtech.jtstest.testbuilder.ui.style
Methods in org.locationtech.jtstest.testbuilder.ui.style with parameters of type Geometry Modifier and Type Method Description void
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
StyleGroup. paint(Geometry geom, Viewport viewport, Graphics2D g)
void
StyleList. paint(Geometry geom, Viewport viewport, Graphics2D g)
void
TintBandStyle. paint(Geometry geom, Viewport viewport, Graphics2D g2d)
void
VertexLabelStyle. 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 Modifier and Type Method Description protected Geometry
BoxBandTool. getBox()
-
Uses of Geometry in org.locationtech.jtstest.testrunner
Methods in org.locationtech.jtstest.testrunner that return Geometry Modifier and Type Method Description Geometry
GeometryResult. getGeometry()
Geometry
TestCase. getGeometryA()
Geometry
TestCase. getGeometryB()
Methods in org.locationtech.jtstest.testrunner with parameters of type Geometry Modifier and Type Method Description boolean
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)
Constructors in org.locationtech.jtstest.testrunner with parameters of type Geometry Constructor Description GeometryResult(Geometry geometry)
TestCase(String description, Geometry a, Geometry b, File aWktFile, File bWktFile, TestRun testRun, int caseIndex, int lineNumber)
Creates a TestCase with the given description. -
Uses of Geometry in org.locationtech.jtstest.util
Methods in org.locationtech.jtstest.util with parameters of type Geometry Modifier and Type Method Description static void
GeometryDataUtil. setComponentDataToIndex(Geometry geom)
-
Uses of Geometry in org.locationtech.jtstest.util.io
Methods in org.locationtech.jtstest.util.io that return Geometry Modifier and Type Method Description Geometry
GeoJsonMultiReader. read(String s)
Geometry
MultiFormatFileReader. read(String filename)
Geometry
MultiFormatReader. read(String geomStr)
Geometry
WKTOrWKBReader. read(String geomStr)
static Geometry
IOUtil. readFile(String filename, GeometryFactory geomFact)
static Geometry
IOUtil. readGeoJSONString(String s, GeometryFactory geomFact)
static Geometry
MultiFormatFileReader. readGeometry(String filename, int limit, int offset, GeometryFactory geomFactory)
static Geometry
IOUtil. readGMLString(String gml, GeometryFactory geomFact)
static Geometry
IOUtil. readWKBHexString(String wkb, GeometryFactory geomFact)
static Geometry
IOUtil. readWKTString(String wkt, GeometryFactory geomFact)
Reads one or more WKT geometries from a string.static Geometry
IOUtil. readWKTString(String wkt, GeometryFactory geomFact, boolean isStrict)
Methods in org.locationtech.jtstest.util.io that return types with arguments of type Geometry Modifier and Type Method Description List<Geometry>
MultiFormatBufferedReader. read(Reader reader)
static List<Geometry>
MultiFormatBufferedReader. read(Reader reader, int limit, int offset, GeometryFactory geomFactory)
static List<Geometry>
MultiFormatFileReader. read(String filename, int limit, int offset, GeometryFactory geomFactory)
List<Geometry>
GeoJsonMultiReader. readList(String s)
List<Geometry>
MultiFormatFileReader. readList(String filename)
List<Geometry>
MultiFormatBufferedReader. readWKT(Reader rdr, GeometryFactory geomFact)
Methods in org.locationtech.jtstest.util.io with parameters of type Geometry Modifier and Type Method Description String
SVGWriter. write(Geometry geometry)
Converts aGeometry
to its Well-known Text representation.void
SVGWriter. write(Geometry geometry, Writer writer)
Converts aGeometry
to its Well-known Text representation.String
SVGWriter. writeFormatted(Geometry geometry)
Same aswrite
, but with newlines and spaces to make the well-known text more readable.void
SVGWriter. writeFormatted(Geometry geometry, Writer writer)
Same aswrite
, but with newlines and spaces to make the well-known text more readable.
-