Uses of Class
org.locationtech.jts.geom.Coordinate
Packages that use Coordinate
Package
Description
Contains classes and interfaces implementing fundamental computational geometry algorithms.
Classes to compute distance metrics between geometries.
Classes to determine the topological location of points in geometries.
Classes to perform conversions from Java2D shape objects.
Classes to perform densification on geometries.
Contains the
Geometry
interface hierarchy and supporting classes.Implementations of interfaces for geometric structures.
Provides classes that parse and modify Geometry objects.
Contains classes that implement topology graphs.
Contains classes that implement indexes for performing noding on geometry graph edges.
Contains classes that implement Monotone Chains
Contains classes which implement a k-D tree index over 2-D point data.
Contains classes that implement a Quadtree spatial index
Contains the interfaces for converting JTS objects to and from other formats.
Classes to read and write the GML2 geometry format.
Contains classes and interfaces implementing linear referencing on linear geometries
Classes to compute nodings for arrangements of line segments and line segment sequences.
Contains classes to implement the Snap Rounding algorithm for noding linestrings.
Provides classes for implementing operations on geometries
Provides classes for computing buffers of geometries
Classes to perform validation of the results of buffer operations.
Provides classes for computing the distance between geometries
Classes to perform line merging.
Contains classes that perform a topological overlay to compute boolean spatial functions.
Classes to perform snapping on geometries to prepare them for overlay operations.
Classes to validate the results of overlay operations.
An API for polygonizing sets of lines.
Classes which implement topological predicates optimized for particular kinds of geometries.
Contains classes to implement the computation of the spatial relationships of
Geometry
s.Provides classes for testing the validity of geometries.
Contains classes to implement a planar graph data structure.
Provides classes for analyzing and
manipulating the precision of Geometries.
Classes which implement algorithms for simplifying or generalizing geometries.
Classes to compute Delaunay triangulations.
Classes to implement a topological subdivision of quadeges, to support creating triangulations
and Voronoi diagrams.
Contains support classes for the Java Topology Suite.
-
Uses of Coordinate in org.locationtech.jts.algorithm
Fields in org.locationtech.jts.algorithm declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
Centroid.areaBasePt
private Coordinate
MinimumBoundingCircle.centre
private Coordinate
InteriorPointLine.centroid
private Coordinate
InteriorPointPoint.centroid
private Coordinate
Centroid.cg3
private Coordinate[]
MinimumDiameter.convexHullPts
private Coordinate
RectangleLineIntersector.diagDown0
private Coordinate
RectangleLineIntersector.diagDown1
private Coordinate
RectangleLineIntersector.diagUp0
private Coordinate
RectangleLineIntersector.diagUp1
private Coordinate[]
MinimumBoundingCircle.extremalPts
protected Coordinate[][]
LineIntersector.inputLines
private Coordinate[]
ConvexHull.inputPts
private Coordinate
InteriorPointArea.interiorPoint
private Coordinate
InteriorPointLine.interiorPoint
private Coordinate
InteriorPointPoint.interiorPoint
protected Coordinate[]
LineIntersector.intPt
private Coordinate
Centroid.lineCentSum
private Coordinate
MinimumDiameter.minWidthPt
private Coordinate
ConvexHull.RadialComparator.origin
private Coordinate
RayCrossingCounter.p
protected Coordinate
LineIntersector.pa
protected Coordinate
LineIntersector.pb
private Coordinate
Centroid.ptCentSum
private Coordinate
Centroid.triangleCent3
Methods in org.locationtech.jts.algorithm that return CoordinateModifier and TypeMethodDescriptionstatic Coordinate
Returns the centre point of the envelope.private Coordinate[]
ConvexHull.cleanRing
(Coordinate[] original) private Coordinate[]
ConvexHull.computeOctPts
(Coordinate[] inputPts) private Coordinate[]
ConvexHull.computeOctRing
(Coordinate[] inputPts) private static Coordinate[]
ConvexHull.extractCoordinates
(Geometry geom) MinimumBoundingCircle.getCentre()
Gets the centre point of the computed Minimum Bounding Circle.Centroid.getCentroid()
Gets the computed centroid.static Coordinate
Centroid.getCentroid
(Geometry geom) Computes the centroid point of a geometry.HCoordinate.getCoordinate()
LineIntersector.getEndpoint
(int segmentIndex, int ptIndex) Gets an endpoint of an input segment.MinimumBoundingCircle.getExtremalPoints()
Gets the extremal points which define the computed Minimum Bounding Circle.InteriorPointArea.getInteriorPoint()
Gets the computed interior point.InteriorPointLine.getInteriorPoint()
InteriorPointPoint.getInteriorPoint()
LineIntersector.getIntersection
(int intIndex) Returns the intIndex'th intersection pointLineIntersector.getIntersectionAlongSegment
(int segmentIndex, int intIndex) Computes the intIndex'th intersection point in the direction of a specified input line segmentMinimumDiameter.getWidthCoordinate()
Gets theCoordinate
forming one end of the minimum diameterstatic Coordinate
CGAlgorithmsDD.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes an intersection point between two lines using DD arithmetic.static Coordinate
HCoordinate.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes the (approximate) intersection point between two line segments using homogeneous coordinates.private Coordinate
RobustLineIntersector.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) This method computes the actual value of the intersection point.private Coordinate
RobustLineIntersector.intersectionWithNormalization
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) private static Coordinate
MinimumBoundingCircle.lowestPoint
(Coordinate[] pts) private static Coordinate
RobustLineIntersector.nearestEndpoint
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Finds the endpoint of the segments P and Q which is closest to the other segment.private Coordinate[]
ConvexHull.padArray3
(Coordinate[] pts) private static Coordinate
MinimumBoundingCircle.pointWithMinAngleWithSegment
(Coordinate[] pts, Coordinate P, Coordinate Q) private static Coordinate
MinimumBoundingCircle.pointWitMinAngleWithX
(Coordinate[] pts, Coordinate P) private Coordinate[]
ConvexHull.preSort
(Coordinate[] pts) private Coordinate[]
ConvexHull.reduce
(Coordinate[] inputPts) Uses a heuristic to reduce the number of points scanned to compute the hull.private Coordinate
RobustLineIntersector.safeHCoordinateIntersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes a segment intersection using homogeneous coordinates.protected Coordinate[]
ConvexHull.toCoordinateArray
(Stack stack) An alternative to Stack.toArray, which is not present in earlier versions of Java.Methods in org.locationtech.jts.algorithm with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
InteriorPointLine.add
(Coordinate point) private void
InteriorPointPoint.add
(Coordinate point) private void
InteriorPointLine.addEndpoints
(Coordinate[] pts) private void
Centroid.addHole
(Coordinate[] pts) private void
InteriorPointLine.addInterior
(Coordinate[] pts) private void
Centroid.addLineSegments
(Coordinate[] pts) Adds the line segments defined by an array of coordinates to the linear centroid accumulators.private void
Centroid.addPoint
(Coordinate pt) Adds a point to the point centroid accumulator.private void
Centroid.addShell
(Coordinate[] pts) private void
Centroid.addTriangle
(Coordinate p0, Coordinate p1, Coordinate p2, boolean isPositiveArea) static double
Angle.angle
(Coordinate p) Returns the angle that the vector from (0,0) to p, relative to the positive X-axis.static double
Angle.angle
(Coordinate p0, Coordinate p1) Returns the angle of the vector from p0 to p1, relative to the positive X-axis.static double
Angle.angleBetween
(Coordinate tip1, Coordinate tail, Coordinate tip2) Returns the unoriented smallest angle between two vectors.static double
Angle.angleBetweenOriented
(Coordinate tip1, Coordinate tail, Coordinate tip2) Returns the oriented smallest angle between two vectors.private static double
Centroid.area2
(Coordinate p1, Coordinate p2, Coordinate p3) Returns twice the signed area of the triangle p1-p2-p3.private static void
Centroid.centroid3
(Coordinate p1, Coordinate p2, Coordinate p3, Coordinate c) Computes three times the centroid of the triangle p1-p2-p3.private void
RobustLineIntersector.checkDD
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2, Coordinate intPt) private Coordinate[]
ConvexHull.cleanRing
(Coordinate[] original) private static double
MinimumDiameter.computeC
(double a, double b, Coordinate p) private int
RobustLineIntersector.computeCollinearIntersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) private void
MinimumDiameter.computeConvexRingMinDiameter
(Coordinate[] pts) Compute the width information for a ring ofCoordinate
s.static double
LineIntersector.computeEdgeDistance
(Coordinate p, Coordinate p0, Coordinate p1) Computes the "edge distance" of an intersection point p along a segment.protected abstract int
LineIntersector.computeIntersect
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) protected int
RobustLineIntersector.computeIntersect
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) abstract void
LineIntersector.computeIntersection
(Coordinate p, Coordinate p1, Coordinate p2) Compute the intersection of a point p and the line p1-p2.void
LineIntersector.computeIntersection
(Coordinate p1, Coordinate p2, Coordinate p3, Coordinate p4) Computes the intersection of the lines p1-p2 and p3-p4.void
RobustLineIntersector.computeIntersection
(Coordinate p, Coordinate p1, Coordinate p2) private void
PointLocator.computeLocation
(Coordinate p, Geometry geom) private Coordinate[]
ConvexHull.computeOctPts
(Coordinate[] inputPts) private Coordinate[]
ConvexHull.computeOctRing
(Coordinate[] inputPts) static int
CGAlgorithms.computeOrientation
(Coordinate p1, Coordinate p2, Coordinate q) Deprecated.Computes the orientation of a point q to the directed line segment p1-p2.void
RayCrossingCounter.countSegment
(Coordinate p1, Coordinate p2) Counts a segmentstatic double
CGAlgorithms3D.distance
(Coordinate p0, Coordinate p1) static double
CGAlgorithms.distanceLineLine
(Coordinate A, Coordinate B, Coordinate C, Coordinate D) Deprecated.Computes the distance from a line segment AB to a line segment CD Note: NON-ROBUST!static double
CGAlgorithms.distancePointLine
(Coordinate p, Coordinate[] line) Deprecated.Computes the distance from a point to a sequence of line segments.static double
CGAlgorithms.distancePointLine
(Coordinate p, Coordinate A, Coordinate B) Deprecated.Computes the distance from a point p to a line segment AB Note: NON-ROBUST!static double
CGAlgorithms.distancePointLinePerpendicular
(Coordinate p, Coordinate A, Coordinate B) Deprecated.Computes the perpendicular distance from a point p to the (infinite) line containing the points ABstatic double
CGAlgorithms3D.distancePointSegment
(Coordinate p, Coordinate A, Coordinate B) static double
CGAlgorithms3D.distanceSegmentSegment
(Coordinate A, Coordinate B, Coordinate C, Coordinate D) Computes the distance between two 3D segments.private int
MinimumDiameter.findMaxPerpDistance
(Coordinate[] pts, LineSegment seg, int startIndex) private Stack
ConvexHull.grahamScan
(Coordinate[] c) Uses the Graham Scan algorithm to compute the convex hull vertices.static int
Orientation.index
(Coordinate p1, Coordinate p2, Coordinate q) Returns the orientation index of the direction of the pointq
relative to a directed infinite line specified byp1-p2
.static double
Angle.interiorAngle
(Coordinate p0, Coordinate p1, Coordinate p2) Computes the interior angle between two segments of a ring.static Coordinate
CGAlgorithmsDD.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes an intersection point between two lines using DD arithmetic.static Coordinate
HCoordinate.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes the (approximate) intersection point between two line segments using homogeneous coordinates.private Coordinate
RobustLineIntersector.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) This method computes the actual value of the intersection point.private Coordinate
RobustLineIntersector.intersectionWithNormalization
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) boolean
PointLocator.intersects
(Coordinate p, Geometry geom) Convenience method to test a point for intersection with a Geometryboolean
RectangleLineIntersector.intersects
(Coordinate p0, Coordinate p1) Tests whether the query rectangle intersects a given line segment.static boolean
Angle.isAcute
(Coordinate p0, Coordinate p1, Coordinate p2) Tests whether the angle between p0-p1-p2 is acute.private boolean
ConvexHull.isBetween
(Coordinate c1, Coordinate c2, Coordinate c3) static boolean
CGAlgorithms.isCCW
(Coordinate[] ring) Deprecated.Computes whether a ring defined by an array ofCoordinate
s is oriented counter-clockwise.static boolean
Orientation.isCCW
(Coordinate[] ring) Computes whether a ring defined by an array ofCoordinate
s is oriented counter-clockwise.static boolean
PointLocation.isInRing
(Coordinate p, Coordinate[] ring) Tests whether a point lies inside or on a ring.private boolean
RobustLineIntersector.isInSegmentEnvelopes
(Coordinate intPt) Tests whether a point lies in the envelopes of both input segments.boolean
LineIntersector.isIntersection
(Coordinate pt) Test whether a point is a intersection point of two line segments.static boolean
Angle.isObtuse
(Coordinate p0, Coordinate p1, Coordinate p2) Tests whether the angle between p0-p1-p2 is obtuse.static boolean
CGAlgorithms.isOnLine
(Coordinate p, Coordinate[] pt) Deprecated.Tests whether a point lies on the line segments defined by a list of coordinates.static boolean
PointLocation.isOnLine
(Coordinate p, Coordinate[] line) Tests whether a point lies on the line defined by a list of coordinates.static boolean
PointLocation.isOnLine
(Coordinate p, CoordinateSequence line) Tests whether a point lies on the line defined by aCoordinateSequence
.static boolean
CGAlgorithms.isPointInRing
(Coordinate p, Coordinate[] ring) Deprecated.Tests whether a point lies inside or on a ring.private Geometry
ConvexHull.lineOrPolygon
(Coordinate[] coordinates) int
PointLocator.locate
(Coordinate p, Geometry geom) Computes the topological relationship (Location
) of a single point to a Geometry.private int
PointLocator.locateInPolygon
(Coordinate p, Polygon poly) private int
PointLocator.locateInPolygonRing
(Coordinate p, LinearRing ring) static int
PointLocation.locateInRing
(Coordinate p, Coordinate[] ring) Determines whether a point lies in the interior, on the boundary, or in the exterior of a ring.private int
PointLocator.locateOnLineString
(Coordinate p, LineString l) private int
PointLocator.locateOnPoint
(Coordinate p, Point pt) static int
CGAlgorithms.locatePointInRing
(Coordinate p, Coordinate[] ring) Deprecated.Determines whether a point lies in the interior, on the boundary, or in the exterior of a ring.static int
RayCrossingCounter.locatePointInRing
(Coordinate p, Coordinate[] ring) Determines theLocation
of a point in a ring.static int
RayCrossingCounter.locatePointInRing
(Coordinate p, CoordinateSequence ring) Determines theLocation
of a point in a ring.private static Coordinate
MinimumBoundingCircle.lowestPoint
(Coordinate[] pts) private static Coordinate
RobustLineIntersector.nearestEndpoint
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Finds the endpoint of the segments P and Q which is closest to the other segment.private static int
MinimumDiameter.nextIndex
(Coordinate[] pts, int index) static double
LineIntersector.nonRobustComputeEdgeDistance
(Coordinate p, Coordinate p1, Coordinate p2) This function is non-robust, since it may compute the square of large numbers.private void
RobustLineIntersector.normalizeToEnvCentre
(Coordinate n00, Coordinate n01, Coordinate n10, Coordinate n11, Coordinate normPt) Normalize the supplied coordinates to so that the midpoint of their intersection envelope lies at the origin.private void
RobustLineIntersector.normalizeToMinimum
(Coordinate n1, Coordinate n2, Coordinate n3, Coordinate n4, Coordinate normPt) Normalize the supplied coordinates so that their minimum ordinate values lie at the origin.static double
Area.ofRing
(Coordinate[] ring) Computes the area for a ring.static double
Area.ofRingSigned
(Coordinate[] ring) Computes the signed area for a ring.static int
CGAlgorithms.orientationIndex
(Coordinate p1, Coordinate p2, Coordinate q) Deprecated.Returns the index of the direction of the pointq
relative to a vector specified byp1-p2
.static int
CGAlgorithmsDD.orientationIndex
(Coordinate p1, Coordinate p2, Coordinate q) Returns the index of the direction of the pointq
relative to a vector specified byp1-p2
.static int
RobustDeterminant.orientationIndex
(Coordinate p1, Coordinate p2, Coordinate q) Returns the index of the direction of the pointq
relative to a vector specified byp1-p2
.private static int
CGAlgorithmsDD.orientationIndexFilter
(Coordinate pa, Coordinate pb, Coordinate pc) A filter for computing the orientation index of three coordinates.private Coordinate[]
ConvexHull.padArray3
(Coordinate[] pts) static double
Distance.pointToLinePerpendicular
(Coordinate p, Coordinate A, Coordinate B) Computes the perpendicular distance from a point p to the (infinite) line containing the points ABstatic double
Distance.pointToSegment
(Coordinate p, Coordinate A, Coordinate B) Computes the distance from a point p to a line segment AB Note: NON-ROBUST!static double
Distance.pointToSegmentString
(Coordinate p, Coordinate[] line) Computes the distance from a point to a sequence of line segments.private static Coordinate
MinimumBoundingCircle.pointWithMinAngleWithSegment
(Coordinate[] pts, Coordinate P, Coordinate Q) private static Coordinate
MinimumBoundingCircle.pointWitMinAngleWithX
(Coordinate[] pts, Coordinate P) private static int
ConvexHull.RadialComparator.polarCompare
(Coordinate o, Coordinate p, Coordinate q) Given two points p and q compare them with respect to their radial ordering about point o.private Coordinate[]
ConvexHull.preSort
(Coordinate[] pts) private Coordinate[]
ConvexHull.reduce
(Coordinate[] inputPts) Uses a heuristic to reduce the number of points scanned to compute the hull.private Coordinate
RobustLineIntersector.safeHCoordinateIntersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes a segment intersection using homogeneous coordinates.static double
Distance.segmentToSegment
(Coordinate A, Coordinate B, Coordinate C, Coordinate D) Computes the distance from a line segment AB to a line segment CD Note: NON-ROBUST!private void
Centroid.setAreaBasePoint
(Coordinate basePt) static double
CGAlgorithms.signedArea
(Coordinate[] ring) Deprecated.Computes the signed area for a ring.Constructors in org.locationtech.jts.algorithm with parameters of type CoordinateModifierConstructorDescriptionConvexHull
(Coordinate[] pts, GeometryFactory geomFactory) Create a new convex hull construction for the inputCoordinate
array.HCoordinate
(Coordinate p1, Coordinate p2) Constructs a homogeneous coordinate which is the intersection of the lines define by the homogenous coordinates represented by twoCoordinate
s.HCoordinate
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) RadialComparator
(Coordinate origin) -
Uses of Coordinate in org.locationtech.jts.algorithm.distance
Fields in org.locationtech.jts.algorithm.distance declared as CoordinateMethods in org.locationtech.jts.algorithm.distance that return CoordinateModifier and TypeMethodDescriptionPointPairDistance.getCoordinate
(int i) DiscreteHausdorffDistance.getCoordinates()
PointPairDistance.getCoordinates()
Methods in org.locationtech.jts.algorithm.distance with parameters of type CoordinateModifier and TypeMethodDescriptionstatic void
DistanceToPoint.computeDistance
(Geometry geom, Coordinate pt, PointPairDistance ptDist) static void
DistanceToPoint.computeDistance
(LineSegment segment, Coordinate pt, PointPairDistance ptDist) static void
DistanceToPoint.computeDistance
(LineString line, Coordinate pt, PointPairDistance ptDist) static void
DistanceToPoint.computeDistance
(Polygon poly, Coordinate pt, PointPairDistance ptDist) void
DiscreteHausdorffDistance.MaxPointDistanceFilter.filter
(Coordinate pt) void
PointPairDistance.initialize
(Coordinate p0, Coordinate p1) private void
PointPairDistance.initialize
(Coordinate p0, Coordinate p1, double distance) Initializes the points, avoiding recomputing the distance.void
PointPairDistance.setMaximum
(Coordinate p0, Coordinate p1) void
PointPairDistance.setMinimum
(Coordinate p0, Coordinate p1) -
Uses of Coordinate in org.locationtech.jts.algorithm.locate
Methods in org.locationtech.jts.algorithm.locate with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
IndexedPointInAreaLocator.IntervalIndexedGeometry.addLine
(Coordinate[] pts) static boolean
SimplePointInAreaLocator.containsPointInPolygon
(Coordinate p, Polygon poly) Determines whether a point lies in aPolygon
.int
IndexedPointInAreaLocator.locate
(Coordinate p) int
PointOnGeometryLocator.locate
(Coordinate p) int
SimplePointInAreaLocator.locate
(Coordinate p) static int
SimplePointInAreaLocator.locate
(Coordinate p, Geometry geom) private static int
SimplePointInAreaLocator.locateInGeometry
(Coordinate p, Geometry geom) static int
SimplePointInAreaLocator.locatePointInPolygon
(Coordinate p, Polygon poly) private static int
SimplePointInAreaLocator.locatePointInRing
(Coordinate p, LinearRing ring) Determines whether a point lies in a LinearRing, using the ring envelope to short-circuit if possible. -
Uses of Coordinate in org.locationtech.jts.awt
Methods in org.locationtech.jts.awt that return CoordinateModifier and TypeMethodDescriptionprivate static Coordinate[]
ShapeReader.nextCoordinateArray
(PathIterator pathIt) Methods in org.locationtech.jts.awt with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
ShapeWriter.appendRing
(PolygonShape poly, Coordinate[] coords) private boolean
ShapeReader.isHole
(Coordinate[] pts) private GeneralPath
PolygonShape.toPath
(Coordinate[] coordinates) Creates a GeneralPath representing a polygon ring having the given coordinate sequence.void
IdentityPointTransformation.transform
(Coordinate model, Point2D view) void
PointTransformation.transform
(Coordinate src, Point2D dest) Transforms aCoordinate
into a Java2DPoint
.private Point2D
ShapeWriter.transformPoint
(Coordinate model) private Point2D
ShapeWriter.transformPoint
(Coordinate model, Point2D view) Constructors in org.locationtech.jts.awt with parameters of type CoordinateModifierConstructorDescriptionPolygonShape
(Coordinate[] shellVertices, Collection holeVerticesCollection) Creates a new polygonShape
. -
Uses of Coordinate in org.locationtech.jts.densify
Methods in org.locationtech.jts.densify that return CoordinateModifier and TypeMethodDescriptionprivate static Coordinate[]
Densifier.densifyPoints
(Coordinate[] pts, double distanceTolerance, PrecisionModel precModel) Densifies a coordinate sequence.Methods in org.locationtech.jts.densify with parameters of type CoordinateModifier and TypeMethodDescriptionprivate static Coordinate[]
Densifier.densifyPoints
(Coordinate[] pts, double distanceTolerance, PrecisionModel precModel) Densifies a coordinate sequence. -
Uses of Coordinate in org.locationtech.jts.dissolve
Methods in org.locationtech.jts.dissolve with parameters of type CoordinateConstructors in org.locationtech.jts.dissolve with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.edgegraph
Fields in org.locationtech.jts.edgegraph declared as CoordinateMethods in org.locationtech.jts.edgegraph that return CoordinateModifier and TypeMethodDescriptionHalfEdge.dest()
Gets the destination coordinate of this edge.HalfEdge.orig()
Gets the origin coordinate of this edge.Methods in org.locationtech.jts.edgegraph with parameters of type CoordinateModifier and TypeMethodDescriptionEdgeGraph.addEdge
(Coordinate orig, Coordinate dest) Adds an edge between the coordinates orig and dest to this graph.private HalfEdge
EdgeGraph.create
(Coordinate p0, Coordinate p1) static HalfEdge
HalfEdge.create
(Coordinate p0, Coordinate p1) Creates a HalfEdge pair representing an edge between two vertices located at coordinates p0 and p1.protected HalfEdge
EdgeGraph.createEdge
(Coordinate orig) Creates a single HalfEdge.boolean
HalfEdge.equals
(Coordinate p0, Coordinate p1) Tests whether this edge has the given orig and dest vertices.HalfEdge.find
(Coordinate dest) Finds the edge starting at the origin of this edge with the given dest vertex, if any.EdgeGraph.findEdge
(Coordinate orig, Coordinate dest) Finds an edge in this graph with the given origin and destination, if one exists.private HalfEdge
EdgeGraph.insert
(Coordinate orig, Coordinate dest, HalfEdge eAdj) Inserts an edge not already present into the graph.static boolean
EdgeGraph.isValidEdge
(Coordinate orig, Coordinate dest) Tests if the given coordinates form a valid edge (with non-zero length).Constructors in org.locationtech.jts.edgegraph with parameters of type CoordinateModifierConstructorDescriptionHalfEdge
(Coordinate orig) Creates an edge originating from a given coordinate.MarkHalfEdge
(Coordinate orig) Creates a new marked edge. -
Uses of Coordinate in org.locationtech.jts.geom
Fields in org.locationtech.jts.geom declared as CoordinateModifier and TypeFieldDescriptionprivate static final Coordinate[]
CoordinateArrays.coordArrayType
private static final Coordinate[]
CoordinateList.coordArrayType
private Coordinate[]
DefaultCoordinateSequence.coordinates
Deprecated.LineSegment.p0
Triangle.p0
The coordinates of the vertices of the triangleLineSegment.p1
Triangle.p1
The coordinates of the vertices of the triangleTriangle.p2
The coordinates of the vertices of the triangleprivate Coordinate
TopologyException.pt
Methods in org.locationtech.jts.geom that return CoordinateModifier and TypeMethodDescriptionstatic Coordinate
Triangle.angleBisector
(Coordinate a, Coordinate b, Coordinate c) Computes the point at which the bisector of the angle ABC cuts the segment AC.static Coordinate[]
CoordinateArrays.atLeastNCoordinatesOrNothing
(int n, Coordinate[] c) Returns either the given coordinate array if its length is greater than the given amount, or an empty coordinate array.Envelope.centre()
Computes the coordinate of the centre of this envelope (as long as it is non-nullTriangle.centroid()
Computes the centroid (centre of mass) of this triangle.static Coordinate
Triangle.centroid
(Coordinate a, Coordinate b, Coordinate c) Computes the centroid (centre of mass) of a triangle.Triangle.circumcentre()
Computes the circumcentre of this triangle.static Coordinate
Triangle.circumcentre
(Coordinate a, Coordinate b, Coordinate c) Computes the circumcentre of a triangle.LineSegment.closestPoint
(Coordinate p) Computes the closest point on this line segment to another point.LineSegment.closestPoints
(LineSegment line) Computes the closest points on two line segments.Coordinate.copy()
static Coordinate[]
CoordinateArrays.copyDeep
(Coordinate[] coordinates) Creates a deep copy of the argumentCoordinate
array.static Coordinate[]
CoordinateArrays.extract
(Coordinate[] pts, int start, int end) CoordinateList.getCoordinate
(int i) CoordinateSequence.getCoordinate
(int i) Returns (possibly a copy of) the i'th coordinate in this sequence.DefaultCoordinateSequence.getCoordinate
(int i) Deprecated.Get the Coordinate with index i.abstract Coordinate
Geometry.getCoordinate()
Returns a vertex of thisGeometry
(usually, but not necessarily, the first one).GeometryCollection.getCoordinate()
LineSegment.getCoordinate
(int i) LineString.getCoordinate()
protected Coordinate
MultiPoint.getCoordinate
(int n) Returns theCoordinate
at the given position.Point.getCoordinate()
Polygon.getCoordinate()
TopologyException.getCoordinate()
CoordinateSequence.getCoordinateCopy
(int i) Returns a copy of the i'th coordinate in this sequence.DefaultCoordinateSequence.getCoordinateCopy
(int i) Deprecated.Get a copy of the Coordinate with index i.LineString.getCoordinateN
(int n) abstract Coordinate[]
Geometry.getCoordinates()
Returns an array containing the values of all the vertices for this geometry.GeometryCollection.getCoordinates()
Collects all coordinates of all subgeometries into an Array.LineString.getCoordinates()
Point.getCoordinates()
Polygon.getCoordinates()
Triangle.inCentre()
Computes the incentre of this triangle.static Coordinate
Triangle.inCentre
(Coordinate a, Coordinate b, Coordinate c) Computes the incentre of a triangle.static Coordinate[]
CoordinateArrays.intersection
(Coordinate[] coordinates, Envelope env) Extracts the coordinates which intersect anEnvelope
.LineSegment.intersection
(LineSegment line) Computes an intersection point between two line segments, if there is one.LineSegment.lineIntersection
(LineSegment line) Computes the intersection point of the lines of infinite extent defined by two line segments (if there is one).LineSegment.midPoint()
Computes the midpoint of the segmentstatic Coordinate
LineSegment.midPoint
(Coordinate p0, Coordinate p1) Computes the midpoint of a segmentstatic Coordinate
CoordinateArrays.minCoordinate
(Coordinate[] coordinates) Returns the minimum coordinate, using the usual lexicographic comparison.LineSegment.pointAlong
(double segmentLengthFraction) Computes theCoordinate
that lies a given fraction along the line defined by this segment.LineSegment.pointAlongOffset
(double segmentLengthFraction, double offsetDistance) Computes theCoordinate
that lies a given fraction along the line defined by this segment and offset from the segment by a given distance.LineSegment.project
(Coordinate p) Compute the projection of a point onto the line determined by this line segment.static Coordinate
CoordinateArrays.ptNotInList
(Coordinate[] testPts, Coordinate[] pts) Finds a point in a list of points which is not contained in another list of pointsstatic Coordinate[]
CoordinateArrays.removeNull
(Coordinate[] coord) Collapses a coordinate array to remove all null elements.static Coordinate[]
CoordinateArrays.removeRepeatedPoints
(Coordinate[] coord) If the coordinate array argument has repeated points, constructs a new array containing no repeated points.static Coordinate[]
CoordinateArrays.toCoordinateArray
(Collection coordList) Converts the given Collection of Coordinates into a Coordinate array.CoordinateList.toCoordinateArray()
Returns the Coordinates in this collection.CoordinateSequence.toCoordinateArray()
Returns (possibly copies of) the Coordinates in this collection.DefaultCoordinateSequence.toCoordinateArray()
Deprecated.This method exposes the internal Array of Coordinate ObjectsPrecisionModel.toExternal
(Coordinate internal) Deprecated.no longer needed, since internal representation is same as external representationPrecisionModel.toInternal
(Coordinate external) Deprecated.use makePrecise insteadMethods in org.locationtech.jts.geom with parameters of type CoordinateModifier and TypeMethodDescriptionvoid
CoordinateList.add
(int i, Coordinate coord, boolean allowRepeated) Inserts the specified coordinate at the specified position in this list.void
CoordinateList.add
(Coordinate coord) boolean
CoordinateList.add
(Coordinate[] coord, boolean allowRepeated) Adds an array of coordinates to the list.boolean
CoordinateList.add
(Coordinate[] coord, boolean allowRepeated, boolean direction) Adds an array of coordinates to the list.boolean
CoordinateList.add
(Coordinate[] coord, boolean allowRepeated, int start, int end) Adds a section of an array of coordinates to the list.void
CoordinateList.add
(Coordinate coord, boolean allowRepeated) Adds a coordinate to the end of the list.static Coordinate
Triangle.angleBisector
(Coordinate a, Coordinate b, Coordinate c) Computes the point at which the bisector of the angle ABC cuts the segment AC.static double
Triangle.area
(Coordinate a, Coordinate b, Coordinate c) Computes the 2D area of a triangle.static double
Triangle.area3D
(Coordinate a, Coordinate b, Coordinate c) Computes the 3D area of a triangle.static Coordinate[]
CoordinateArrays.atLeastNCoordinatesOrNothing
(int n, Coordinate[] c) Returns either the given coordinate array if its length is greater than the given amount, or an empty coordinate array.static Coordinate
Triangle.centroid
(Coordinate a, Coordinate b, Coordinate c) Computes the centroid (centre of mass) of a triangle.static Coordinate
Triangle.circumcentre
(Coordinate a, Coordinate b, Coordinate c) Computes the circumcentre of a triangle.LineSegment.closestPoint
(Coordinate p) Computes the closest point on this line segment to another point.static int
CoordinateArrays.compare
(Coordinate[] pts1, Coordinate[] pts2) Compares twoCoordinate
arrays in the forward direction of their coordinates, using lexicographic ordering.boolean
Envelope.contains
(Coordinate p) Tests if the given point lies in or on the envelope.static Coordinate[]
CoordinateArrays.copyDeep
(Coordinate[] coordinates) Creates a deep copy of the argumentCoordinate
array.static void
CoordinateArrays.copyDeep
(Coordinate[] src, int srcStart, Coordinate[] dest, int destStart, int length) Creates a deep copy of a given section of a sourceCoordinate
array into a destination Coordinate array.boolean
Envelope.covers
(Coordinate p) Tests if the given point lies in or on the envelope.CoordinateSequenceFactory.create
(Coordinate[] coordinates) Returns aCoordinateSequence
based on the given array.DefaultCoordinateSequenceFactory.create
(Coordinate[] coordinates) Deprecated.Returns a DefaultCoordinateSequence based on the given array (the array is not copied).GeometryFactory.createLinearRing
(Coordinate[] coordinates) Creates aLinearRing
using the givenCoordinate
s.GeometryFactory.createLineString
(Coordinate[] coordinates) Creates a LineString using the given Coordinates.GeometryFactory.createMultiPoint
(Coordinate[] coordinates) Deprecated.GeometryFactory.createMultiPointFromCoords
(Coordinate[] coordinates) Creates aMultiPoint
using the givenCoordinate
s.GeometryFactory.createPoint
(Coordinate coordinate) Creates a Point using the given Coordinate.private Point
Geometry.createPointFromInternalCoord
(Coordinate coord, Geometry exemplar) static Point
GeometryFactory.createPointFromInternalCoord
(Coordinate coord, Geometry exemplar) GeometryFactory.createPolygon
(Coordinate[] shell) Constructs aPolygon
with the given exterior boundary.double
Coordinate.distance
(Coordinate c) Computes the 2-dimensional Euclidean distance to another location.double
LineSegment.distance
(Coordinate p) Computes the distance between this line segment and a given point.double
Coordinate.distance3D
(Coordinate c) Computes the 3-dimensional Euclidean distance to another location.double
LineSegment.distancePerpendicular
(Coordinate p) Computes the perpendicular distance between the (infinite) line defined by this line segment and a point.static Envelope
CoordinateArrays.envelope
(Coordinate[] coordinates) Computes the envelope of the coordinates.protected boolean
Geometry.equal
(Coordinate a, Coordinate b, double tolerance) boolean
Coordinate.equalInZ
(Coordinate c, double tolerance) Tests if another coordinate has the same value for Z, within a tolerance.static boolean
CoordinateArrays.equals
(Coordinate[] coord1, Coordinate[] coord2) Returns true if the two arrays are identical, both null, or pointwise equal (as compared using Coordinate#equals)static boolean
CoordinateArrays.equals
(Coordinate[] coord1, Coordinate[] coord2, Comparator coordinateComparator) Returns true if the two arrays are identical, both null, or pointwise equal, using a user-definedComparator
forCoordinate
sboolean
Coordinate.equals2D
(Coordinate other) Returns whether the planar projections of the twoCoordinate
s are equal.boolean
Coordinate.equals2D
(Coordinate c, double tolerance) Tests if another coordinate has the same values for the X and Y ordinates.boolean
Coordinate.equals3D
(Coordinate other) Tests if another coordinate has the same values for the X, Y and Z ordinates.void
Envelope.expandToInclude
(Coordinate p) Enlarges thisEnvelope
so that it contains the givenCoordinate
.OctagonalEnvelope.expandToInclude
(Coordinate p) static Coordinate[]
CoordinateArrays.extract
(Coordinate[] pts, int start, int end) void
CoordinateFilter.filter
(Coordinate coord) Performs an operation with thecoord
.void
CoordinateSequence.getCoordinate
(int index, Coordinate coord) Copies the i'th coordinate in the sequence to the suppliedCoordinate
.void
DefaultCoordinateSequence.getCoordinate
(int index, Coordinate coord) Deprecated.static boolean
CoordinateArrays.hasRepeatedPoints
(Coordinate[] coord) Returns whether #equals returns true for any two consecutive Coordinates in the given array.static Coordinate
Triangle.inCentre
(Coordinate a, Coordinate b, Coordinate c) Computes the incentre of a triangle.static int
CoordinateArrays.increasingDirection
(Coordinate[] pts) Determines which orientation of theCoordinate
array is (overall) increasing.static int
CoordinateArrays.indexOf
(Coordinate coordinate, Coordinate[] coordinates) Returns the index ofcoordinate
incoordinates
.void
Envelope.init
(Coordinate p) Initialize anEnvelope
to a region defined by a single Coordinate.void
Envelope.init
(Coordinate p1, Coordinate p2) Initialize anEnvelope
to a region defined by two Coordinates.double
Triangle.interpolateZ
(Coordinate p) Computes the Z-value (elevation) of an XY point on a three-dimensional plane defined by this triangle (whose vertices must have Z-values).static double
Triangle.interpolateZ
(Coordinate p, Coordinate v0, Coordinate v1, Coordinate v2) Computes the Z-value (elevation) of an XY point on a three-dimensional plane defined by a triangle whose vertices have Z-values.static Coordinate[]
CoordinateArrays.intersection
(Coordinate[] coordinates, Envelope env) Extracts the coordinates which intersect anEnvelope
.boolean
Envelope.intersects
(Coordinate p) Check if the pointp
intersects (lies inside) the region of thisEnvelope
.boolean
Envelope.intersects
(Coordinate a, Coordinate b) Check if the extent defined by two extremal points intersects the extent of thisEnvelope
.static boolean
Envelope.intersects
(Coordinate p1, Coordinate p2, Coordinate q) Test the point q to see whether it intersects the Envelope defined by p1-p2static boolean
Envelope.intersects
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Tests whether the envelope defined by p1-p2 and the envelope defined by q1-q2 intersect.boolean
OctagonalEnvelope.intersects
(Coordinate p) static boolean
Triangle.isAcute
(Coordinate a, Coordinate b, Coordinate c) Tests whether a triangle is acute.boolean
LineString.isCoordinate
(Coordinate pt) Returns true if the given point is a vertex of thisLineString
.private static boolean
CoordinateArrays.isEqualReversed
(Coordinate[] pts1, Coordinate[] pts2) Determines whether twoCoordinate
arrays of equal length are equal in opposite directions.static boolean
CoordinateArrays.isRing
(Coordinate[] pts) Tests whether an array ofCoordinate
s forms a ring, by checking length and closure.static double
Triangle.longestSideLength
(Coordinate a, Coordinate b, Coordinate c) Computes the length of the longest side of a trianglevoid
PrecisionModel.makePrecise
(Coordinate coord) Rounds a Coordinate to the PrecisionModel grid.static Coordinate
LineSegment.midPoint
(Coordinate p0, Coordinate p1) Computes the midpoint of a segmentstatic Coordinate
CoordinateArrays.minCoordinate
(Coordinate[] coordinates) Returns the minimum coordinate, using the usual lexicographic comparison.private static String
TopologyException.msgWithCoord
(String msg, Coordinate pt) int
LineSegment.orientationIndex
(Coordinate p) Determines the orientation index of aCoordinate
relative to this segment.boolean
Envelope.overlaps
(Coordinate p) Deprecated.Use #intersects instead.static HCoordinate
Triangle.perpendicularBisector
(Coordinate a, Coordinate b) Computes the line which is the perpendicular bisector of the line segment a-b.LineSegment.project
(Coordinate p) Compute the projection of a point onto the line determined by this line segment.double
LineSegment.projectionFactor
(Coordinate p) Computes the Projection Factor for the projection of the point p onto this LineSegment.static Coordinate
CoordinateArrays.ptNotInList
(Coordinate[] testPts, Coordinate[] pts) Finds a point in a list of points which is not contained in another list of pointsstatic Coordinate[]
CoordinateArrays.removeNull
(Coordinate[] coord) Collapses a coordinate array to remove all null elements.static Coordinate[]
CoordinateArrays.removeRepeatedPoints
(Coordinate[] coord) If the coordinate array argument has repeated points, constructs a new array containing no repeated points.static void
CoordinateArrays.reverse
(Coordinate[] coord) Reverses the coordinates in an array in-place.static void
CoordinateArrays.scroll
(Coordinate[] coordinates, Coordinate firstCoordinate) Shifts the positions of the coordinates untilfirstCoordinate
is first.double
LineSegment.segmentFraction
(Coordinate inputPt) Computes the fraction of distance (in [0.0, 1.0]) that the projection of a point occurs along this line segment.void
Coordinate.setCoordinate
(Coordinate other) Sets thisCoordinate
s (x,y,z) values to that ofother
.void
LineSegment.setCoordinates
(Coordinate p0, Coordinate p1) static double
Triangle.signedArea
(Coordinate a, Coordinate b, Coordinate c) Computes the signed 2D area of a triangle.PrecisionModel.toExternal
(Coordinate internal) Deprecated.no longer needed, since internal representation is same as external representationvoid
PrecisionModel.toExternal
(Coordinate internal, Coordinate external) Deprecated.no longer needed, since internal representation is same as external representationPrecisionModel.toInternal
(Coordinate external) Deprecated.use makePrecise insteadvoid
PrecisionModel.toInternal
(Coordinate external, Coordinate internal) Deprecated.use makePrecise insteadConstructors in org.locationtech.jts.geom with parameters of type CoordinateModifierConstructorDescriptionConstructs aCoordinate
having the same (x,y,z) values asother
.CoordinateList
(Coordinate[] coord) Constructs a new list from an array of Coordinates, allowing repeated points.CoordinateList
(Coordinate[] coord, boolean allowRepeated) Constructs a new list from an array of Coordinates, allowing caller to specify if repeated points are to be removed.DefaultCoordinateSequence
(Coordinate[] coordinates) Deprecated.Constructs a DefaultCoordinateSequence based on the given array (the array is not copied).Creates anEnvelope
for a region defined by a single Coordinate.Envelope
(Coordinate p1, Coordinate p2) Creates anEnvelope
for a region defined by two Coordinates.private
LinearRing
(Coordinate[] points, GeometryFactory factory) This method is ONLY used to avoid deprecation warnings.LinearRing
(Coordinate[] points, PrecisionModel precisionModel, int SRID) Deprecated.Use GeometryFactory insteadLineSegment
(Coordinate p0, Coordinate p1) LineString
(Coordinate[] points, PrecisionModel precisionModel, int SRID) Deprecated.Use GeometryFactory insteadCreates a new null bounding octagon bounding aCoordinate
OctagonalEnvelope
(Coordinate p0, Coordinate p1) Creates a new null bounding octagon bounding a pair ofCoordinate
sPoint
(Coordinate coordinate, PrecisionModel precisionModel, int SRID) Deprecated.Use GeometryFactory insteadTopologyException
(String msg, Coordinate pt) Triangle
(Coordinate p0, Coordinate p1, Coordinate p2) Creates a new triangle with the given vertices. -
Uses of Coordinate in org.locationtech.jts.geom.impl
Fields in org.locationtech.jts.geom.impl declared as CoordinateMethods in org.locationtech.jts.geom.impl that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate[]
PackedCoordinateSequence.getCachedCoords()
CoordinateArraySequence.getCoordinate
(int i) Get the Coordinate with index i.PackedCoordinateSequence.getCoordinate
(int i) CoordinateArraySequence.getCoordinateCopy
(int i) Get a copy of the Coordinate with index i.PackedCoordinateSequence.getCoordinateCopy
(int i) PackedCoordinateSequence.Double.getCoordinateInternal
(int i) PackedCoordinateSequence.Float.getCoordinateInternal
(int i) protected abstract Coordinate
PackedCoordinateSequence.getCoordinateInternal
(int index) Returns a Coordinate representation of the specified coordinate, by always building a new Coordinate objectCoordinateArraySequence.toCoordinateArray()
This method exposes the internal Array of Coordinate ObjectsPackedCoordinateSequence.toCoordinateArray()
Methods in org.locationtech.jts.geom.impl with parameters of type CoordinateModifier and TypeMethodDescriptionCoordinateArraySequenceFactory.create
(Coordinate[] coordinates) Returns aCoordinateArraySequence
based on the given array (the array is not copied).PackedCoordinateSequenceFactory.create
(Coordinate[] coordinates) void
CoordinateArraySequence.getCoordinate
(int index, Coordinate coord) void
PackedCoordinateSequence.getCoordinate
(int i, Coordinate coord) Constructors in org.locationtech.jts.geom.impl with parameters of type CoordinateModifierConstructorDescriptionCoordinateArraySequence
(Coordinate[] coordinates) Constructs a sequence based on the given array ofCoordinate
s (the array is not copied).CoordinateArraySequence
(Coordinate[] coordinates, int dimension) Constructs a sequence based on the given array ofCoordinate
s (the array is not copied).Double
(Coordinate[] coordinates) Builds a new packed coordinate sequence out of a coordinate arrayDouble
(Coordinate[] coordinates, int dimension) Builds a new packed coordinate sequence out of a coordinate arrayFloat
(Coordinate[] coordinates, int dimension) Constructs a packed coordinate sequence out of a coordinate array -
Uses of Coordinate in org.locationtech.jts.geom.util
Fields in org.locationtech.jts.geom.util declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
AffineTransformationBuilder.dest0
private Coordinate
AffineTransformationBuilder.dest1
private Coordinate
AffineTransformationBuilder.dest2
private Coordinate
AffineTransformationBuilder.src0
private Coordinate
AffineTransformationBuilder.src1
private Coordinate
AffineTransformationBuilder.src2
Methods in org.locationtech.jts.geom.util that return CoordinateModifier and TypeMethodDescriptionabstract Coordinate[]
GeometryEditor.CoordinateOperation.edit
(Coordinate[] coordinates, Geometry geometry) Edits the array ofCoordinate
s from aGeometry
.AffineTransformation.transform
(Coordinate src, Coordinate dest) Applies this transformation to the src coordinate and places the results in the dest coordinate (which may be the same as the source).Methods in org.locationtech.jts.geom.util with parameters of type CoordinateModifier and TypeMethodDescriptionprotected final CoordinateSequence
GeometryTransformer.createCoordinateSequence
(Coordinate[] coords) Convenience method which provides standard way of creating aCoordinateSequence
static AffineTransformation
AffineTransformationFactory.createFromBaseLines
(Coordinate src0, Coordinate src1, Coordinate dest0, Coordinate dest1) Creates an AffineTransformation defined by a mapping between two baselines.static AffineTransformation
AffineTransformationFactory.createFromControlVectors
(Coordinate[] src, Coordinate[] dest) Creates an AffineTransformation defined by a set of control vectors.static AffineTransformation
AffineTransformationFactory.createFromControlVectors
(Coordinate src0, Coordinate dest0) Creates an AffineTransformation defined by a single control vector.static AffineTransformation
AffineTransformationFactory.createFromControlVectors
(Coordinate src0, Coordinate src1, Coordinate dest0, Coordinate dest1) Creates an AffineTransformation defined by a pair of control vectors.static AffineTransformation
AffineTransformationFactory.createFromControlVectors
(Coordinate src0, Coordinate src1, Coordinate src2, Coordinate dest0, Coordinate dest1, Coordinate dest2) Creates a transformation from a set of three control vectors.abstract Coordinate[]
GeometryEditor.CoordinateOperation.edit
(Coordinate[] coordinates, Geometry geometry) Edits the array ofCoordinate
s from aGeometry
.AffineTransformation.transform
(Coordinate src, Coordinate dest) Applies this transformation to the src coordinate and places the results in the dest coordinate (which may be the same as the source).Constructors in org.locationtech.jts.geom.util with parameters of type CoordinateModifierConstructorDescriptionAffineTransformation
(Coordinate src0, Coordinate src1, Coordinate src2, Coordinate dest0, Coordinate dest1, Coordinate dest2) Constructs a transformation which maps the given source points into the given destination points.AffineTransformationBuilder
(Coordinate src0, Coordinate src1, Coordinate src2, Coordinate dest0, Coordinate dest1, Coordinate dest2) Constructs a new builder for the transformation defined by the given set of control point mappings. -
Uses of Coordinate in org.locationtech.jts.geomgraph
Fields in org.locationtech.jts.geomgraph declared as CoordinateModifier and TypeFieldDescriptionEdgeIntersection.coord
protected Coordinate
Node.coord
private Coordinate
GeometryGraph.invalidPoint
private Coordinate
EdgeEnd.p0
private Coordinate
EdgeEnd.p1
(package private) Coordinate[]
Edge.pts
Methods in org.locationtech.jts.geomgraph that return CoordinateModifier and TypeMethodDescriptionGeometryGraph.getBoundaryPoints()
Edge.getCoordinate()
Edge.getCoordinate
(int i) EdgeEnd.getCoordinate()
EdgeEndStar.getCoordinate()
EdgeIntersection.getCoordinate()
EdgeRing.getCoordinate
(int i) abstract Coordinate
GraphComponent.getCoordinate()
Node.getCoordinate()
Edge.getCoordinates()
EdgeEnd.getDirectedCoordinate()
GeometryGraph.getInvalidPoint()
Methods in org.locationtech.jts.geomgraph with parameters of type CoordinateModifier and TypeMethodDescriptionEdgeIntersectionList.add
(Coordinate intPt, int segmentIndex, double dist) Adds an intersection into the list, if it isn't already there.NodeMap.addNode
(Coordinate coord) This method expects that a node has a coordinate value.PlanarGraph.addNode
(Coordinate coord) void
GeometryGraph.addPoint
(Coordinate pt) Add a point computed externally.private void
GeometryGraph.addSelfIntersectionNode
(int argIndex, Coordinate coord, int loc) Add a node for a self-intersection.boolean
EdgeRing.containsPoint
(Coordinate p) This method will cause the ring to be computed.NodeFactory.createNode
(Coordinate coord) The basic node constructor does not allow for incident edgesNodeMap.find
(Coordinate coord) PlanarGraph.find
(Coordinate coord) PlanarGraph.findEdge
(Coordinate p0, Coordinate p1) Returns the edge whose first two coordinates are p0 and p1PlanarGraph.findEdgeInSameDirection
(Coordinate p0, Coordinate p1) Returns the edge which starts at p0 and whose first segment is parallel to p1private int
EdgeEndStar.getLocation
(int geomIndex, Coordinate p, GeometryGraph[] geom) protected void
EdgeEnd.init
(Coordinate p0, Coordinate p1) private void
GeometryGraph.insertBoundaryPoint
(int argIndex, Coordinate coord) Adds candidate boundary points using the currentBoundaryNodeRule
.private void
GeometryGraph.insertPoint
(int argIndex, Coordinate coord, int onLocation) boolean
PlanarGraph.isBoundaryNode
(int geomIndex, Coordinate coord) boolean
EdgeIntersectionList.isIntersection
(Coordinate pt) Tests if the given point is an edge intersectionint
GeometryGraph.locate
(Coordinate pt) Determines theLocation
of the givenCoordinate
in this geometry.private boolean
PlanarGraph.matchInSameDirection
(Coordinate p0, Coordinate p1, Coordinate ep0, Coordinate ep1) The coordinate pairs match if they define line segments lying in the same direction.static int
Quadrant.quadrant
(Coordinate p0, Coordinate p1) Returns the quadrant of a directed line segment from p0 to p1.Constructors in org.locationtech.jts.geomgraph with parameters of type CoordinateModifierConstructorDescriptionEdge
(Coordinate[] pts) Edge
(Coordinate[] pts, Label label) EdgeEnd
(Edge edge, Coordinate p0, Coordinate p1) EdgeEnd
(Edge edge, Coordinate p0, Coordinate p1, Label label) EdgeIntersection
(Coordinate coord, int segmentIndex, double dist) Node
(Coordinate coord, EdgeEndStar edges) -
Uses of Coordinate in org.locationtech.jts.geomgraph.index
Fields in org.locationtech.jts.geomgraph.index declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
SegmentIntersector.properIntersectionPoint
(package private) Coordinate[]
MonotoneChainEdge.pts
(package private) Coordinate[]
SweepLineSegment.pts
Methods in org.locationtech.jts.geomgraph.index that return CoordinateModifier and TypeMethodDescriptionMonotoneChainEdge.getCoordinates()
SegmentIntersector.getProperIntersectionPoint()
Methods in org.locationtech.jts.geomgraph.index with parameters of type CoordinateModifier and TypeMethodDescriptionprivate int
MonotoneChainIndexer.findChainEnd
(Coordinate[] pts, int start) int[]
MonotoneChainIndexer.getChainStartIndices
(Coordinate[] pts) -
Uses of Coordinate in org.locationtech.jts.index.chain
Fields in org.locationtech.jts.index.chain declared as CoordinateMethods in org.locationtech.jts.index.chain that return CoordinateModifier and TypeMethodDescriptionMonotoneChain.getCoordinates()
Return the subsequence of coordinates forming this chain.Methods in org.locationtech.jts.index.chain with parameters of type CoordinateModifier and TypeMethodDescriptionprivate static int
MonotoneChainBuilder.findChainEnd
(Coordinate[] pts, int start) Finds the index of the last point in a monotone chain starting at a given point.static List
MonotoneChainBuilder.getChains
(Coordinate[] pts) static List
MonotoneChainBuilder.getChains
(Coordinate[] pts, Object context) Return a list of theMonotoneChain
s for the given list of coordinates.static int[]
MonotoneChainBuilder.getChainStartIndices
(Coordinate[] pts) Return an array containing lists of start/end indexes of the monotone chains for the given list of coordinates.Constructors in org.locationtech.jts.index.chain with parameters of type CoordinateModifierConstructorDescriptionMonotoneChain
(Coordinate[] pts, int start, int end, Object context) -
Uses of Coordinate in org.locationtech.jts.index.kdtree
Fields in org.locationtech.jts.index.kdtree declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
KdNode.p
private Coordinate
KdTree.BestMatchVisitor.p
Methods in org.locationtech.jts.index.kdtree that return CoordinateModifier and TypeMethodDescriptionKdNode.getCoordinate()
Returns the location of this nodestatic Coordinate[]
KdTree.toCoordinates
(Collection kdnodes) Converts a collection ofKdNode
s to an array ofCoordinate
s.static Coordinate[]
KdTree.toCoordinates
(Collection kdnodes, boolean includeRepeated) Converts a collection ofKdNode
s to an array ofCoordinate
s, specifying whether repeated nodes should be represented by multiple coordinates.Methods in org.locationtech.jts.index.kdtree with parameters of type CoordinateModifier and TypeMethodDescriptionprivate KdNode
KdTree.findBestMatchNode
(Coordinate p) Finds the node in the tree which is the best match for a point being inserted.KdTree.insert
(Coordinate p) Inserts a new point in the kd-tree, with no data.KdTree.insert
(Coordinate p, Object data) Inserts a new point into the kd-tree.private KdNode
KdTree.insertExact
(Coordinate p, Object data) Inserts a point known to be beyond the distance tolerance of any existing node.Constructors in org.locationtech.jts.index.kdtree with parameters of type CoordinateModifierConstructorDescriptionBestMatchVisitor
(Coordinate p, double tolerance) KdNode
(Coordinate p, Object data) Creates a new KdNode. -
Uses of Coordinate in org.locationtech.jts.index.quadtree
Fields in org.locationtech.jts.index.quadtree declared as CoordinateModifier and TypeFieldDescriptionprivate static final Coordinate
Root.origin
private Coordinate
Key.pt
Methods in org.locationtech.jts.index.quadtree that return Coordinate -
Uses of Coordinate in org.locationtech.jts.io
Methods in org.locationtech.jts.io that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate[]
WKTReader.getCoordinates()
Returns the next array ofCoordinate
s in the stream.private Coordinate[]
WKTReader.getCoordinatesNoLeftParen()
private Coordinate
WKTReader.getPreciseCoordinate()
Methods in org.locationtech.jts.io with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
WKTWriter.appendCoordinate
(Coordinate coordinate, Writer writer) Converts aCoordinate
to<Point>
format, then appends it to the writer.private void
WKTWriter.appendPointTaggedText
(Coordinate coordinate, int level, Writer writer, PrecisionModel precisionModel) Converts aCoordinate
to <Point Tagged Text> format, then appends it to the writer.private void
WKTWriter.appendPointText
(Coordinate coordinate, int level, Writer writer, PrecisionModel precisionModel) Converts aCoordinate
to <Point Text> format, then appends it to the writer.static String
WKTWriter.toLineString
(Coordinate[] coord) Generates the WKT for a LINESTRING specified by aCoordinateSequence
.static String
WKTWriter.toLineString
(Coordinate p0, Coordinate p1) Generates the WKT for a LINESTRING specified by twoCoordinate
s.static String
WKTWriter.toPoint
(Coordinate p0) Generates the WKT for a POINT specified by aCoordinate
.private Point[]
WKTReader.toPoints
(Coordinate[] coordinates) Creates an array ofPoint
s having the givenCoordinate
s. -
Uses of Coordinate in org.locationtech.jts.io.gml2
Methods in org.locationtech.jts.io.gml2 with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
GMLWriter.write
(Coordinate[] coords, Writer writer, int level) Takes a list of coordinates and converts it to GML.
2d and 3d aware. -
Uses of Coordinate in org.locationtech.jts.io.kml
Methods in org.locationtech.jts.io.kml with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
KMLWriter.write
(Coordinate[] coords, int level, StringBuffer buf) Takes a list of coordinates and converts it to KML.
2d and 3d aware.private void
KMLWriter.write
(Coordinate p, StringBuffer buf) -
Uses of Coordinate in org.locationtech.jts.linearref
Fields in org.locationtech.jts.linearref declared as CoordinateMethods in org.locationtech.jts.linearref that return CoordinateModifier and TypeMethodDescriptionLengthIndexedLine.extractPoint
(double index) Computes theCoordinate
for the point on the line at the given index.LengthIndexedLine.extractPoint
(double index, double offsetDistance) Computes theCoordinate
for the point on the line at the given index, offset by the given distance.LocationIndexedLine.extractPoint
(LinearLocation index) Computes theCoordinate
for the point on the line at the given index.LocationIndexedLine.extractPoint
(LinearLocation index, double offsetDistance) Computes theCoordinate
for the point on the line at the given index, offset by the given distance.LinearLocation.getCoordinate
(Geometry linearGeom) Gets theCoordinate
along the given linearGeometry
which is referenced by this location.LinearGeometryBuilder.getLastCoordinate()
LinearIterator.getSegmentEnd()
Gets the secondCoordinate
of the current segment.LinearIterator.getSegmentStart()
Gets the firstCoordinate
of the current segment.static Coordinate
LinearLocation.pointAlongSegmentByFraction
(Coordinate p0, Coordinate p1, double frac) Computes theCoordinate
of a point a given fraction along the line segment (p0, p1).private Coordinate[]
LinearGeometryBuilder.validCoordinateSequence
(Coordinate[] pts) Methods in org.locationtech.jts.linearref with parameters of type CoordinateModifier and TypeMethodDescriptionvoid
LinearGeometryBuilder.add
(Coordinate pt) Adds a point to the current line.void
LinearGeometryBuilder.add
(Coordinate pt, boolean allowRepeatedPoints) Adds a point to the current line.double
LengthIndexedLine.indexOf
(Coordinate pt) Computes the minimum index for a point on the line.double
LengthIndexOfPoint.indexOf
(Coordinate inputPt) Find the nearest location along a linearGeometry
to a given point.static double
LengthIndexOfPoint.indexOf
(Geometry linearGeom, Coordinate inputPt) LocationIndexedLine.indexOf
(Coordinate pt) Computes the index for a given point on the line.LocationIndexOfPoint.indexOf
(Coordinate inputPt) Find the nearest location along a linearGeometry
to a given point.static LinearLocation
LocationIndexOfPoint.indexOf
(Geometry linearGeom, Coordinate inputPt) double
LengthIndexedLine.indexOfAfter
(Coordinate pt, double minIndex) Finds the index for a point on the line which is greater than the given index.double
LengthIndexOfPoint.indexOfAfter
(Coordinate inputPt, double minIndex) Finds the nearest index along the linearGeometry
to a givenCoordinate
after the specified minimum index.static double
LengthIndexOfPoint.indexOfAfter
(Geometry linearGeom, Coordinate inputPt, double minIndex) LocationIndexedLine.indexOfAfter
(Coordinate pt, LinearLocation minIndex) Finds the index for a point on the line which is greater than the given index.LocationIndexOfPoint.indexOfAfter
(Coordinate inputPt, LinearLocation minIndex) Find the nearestLinearLocation
along the linearGeometry
to a givenCoordinate
after the specified minimumLinearLocation
.static LinearLocation
LocationIndexOfPoint.indexOfAfter
(Geometry linearGeom, Coordinate inputPt, LinearLocation minIndex) private double
LengthIndexOfPoint.indexOfFromStart
(Coordinate inputPt, double minIndex) private LinearLocation
LocationIndexOfPoint.indexOfFromStart
(Coordinate inputPt, LinearLocation minIndex) static Coordinate
LinearLocation.pointAlongSegmentByFraction
(Coordinate p0, Coordinate p1, double frac) Computes theCoordinate
of a point a given fraction along the line segment (p0, p1).double
LengthIndexedLine.project
(Coordinate pt) Computes the index for the closest point on the line to the given point.LocationIndexedLine.project
(Coordinate pt) Computes the index for the closest point on the line to the given point.private double
LengthIndexOfPoint.segmentNearestMeasure
(LineSegment seg, Coordinate inputPt, double segmentStartMeasure) private Coordinate[]
LinearGeometryBuilder.validCoordinateSequence
(Coordinate[] pts) -
Uses of Coordinate in org.locationtech.jts.math
Fields in org.locationtech.jts.math declared as CoordinateMethods in org.locationtech.jts.math that return CoordinateModifier and TypeMethodDescriptionstatic Coordinate
Vector3D.normalize
(Coordinate v) Vector2D.toCoordinate()
Vector2D.translate
(Coordinate coord) Methods in org.locationtech.jts.math with parameters of type CoordinateModifier and TypeMethodDescriptionstatic Vector2D
Vector2D.create
(Coordinate coord) Creates a vector from aCoordinate
.static Vector2D
Vector2D.create
(Coordinate from, Coordinate to) Creates a vector with the direction and magnitude of the difference between the to and fromCoordinate
s.static Vector3D
Vector3D.create
(Coordinate coord) Creates a vector from aCoordinate
.static double
Vector3D.dot
(Coordinate v1, Coordinate v2) Computes the 3D dot-product of twoCoordinate
s.static double
Vector3D.dot
(Coordinate A, Coordinate B, Coordinate C, Coordinate D) Computes the dot product of the 3D vectors AB and CD.static double
Vector3D.length
(Coordinate v) static Coordinate
Vector3D.normalize
(Coordinate v) double
Plane3D.orientedDistance
(Coordinate p) Computes the oriented distance from a point to the plane.Vector2D.translate
(Coordinate coord) Constructors in org.locationtech.jts.math with parameters of type CoordinateModifierConstructorDescriptionPlane3D
(Vector3D normal, Coordinate basePt) Vector2D
(Coordinate from, Coordinate to) Vector3D
(Coordinate from, Coordinate to) -
Uses of Coordinate in org.locationtech.jts.noding
Fields in org.locationtech.jts.noding declared as CoordinateModifier and TypeFieldDescriptionfinal Coordinate
SegmentNode.coord
private Coordinate
InteriorIntersectionFinder.interiorIntersection
private Coordinate
SegmentIntersectionDetector.intPt
private Coordinate[]
InteriorIntersectionFinder.intSegments
private Coordinate[]
SegmentIntersectionDetector.intSegments
private Coordinate
IntersectionAdder.properIntersectionPoint
private Coordinate[]
BasicSegmentString.pts
private Coordinate[]
NodedSegmentString.pts
private Coordinate[]
OrientedCoordinateArray.pts
Methods in org.locationtech.jts.noding that return CoordinateModifier and TypeMethodDescriptionBasicSegmentString.getCoordinate
(int i) NodedSegmentString.getCoordinate
(int i) SegmentNode.getCoordinate()
Gets theCoordinate
giving the location of this node.SegmentString.getCoordinate
(int i) BasicSegmentString.getCoordinates()
NodedSegmentString.getCoordinates()
SegmentString.getCoordinates()
InteriorIntersectionFinder.getInteriorIntersection()
Gets the computed location of the intersection.SegmentIntersectionDetector.getIntersection()
Gets the computed location of the intersection.InteriorIntersectionFinder.getIntersectionSegments()
Gets the endpoints of the intersecting segments.SegmentIntersectionDetector.getIntersectionSegments()
Gets the endpoints of the intersecting segments.IntersectionAdder.getProperIntersectionPoint()
SegmentNodeList.getSplitCoordinates()
Gets the list of coordinates for the fully noded segment string, including all original segment string vertices and vertices introduced by nodes in this list.private Coordinate[]
ScaledNoder.scale
(Coordinate[] pts) Methods in org.locationtech.jts.noding with parameters of type CoordinateModifier and TypeMethodDescriptionSegmentNodeList.add
(Coordinate intPt, int segmentIndex) Adds an intersection into the list, if it isn't already there.void
NodableSegmentString.addIntersection
(Coordinate intPt, int segmentIndex) Adds an intersection node for a given point and segment to this segment string.void
NodedSegmentString.addIntersection
(Coordinate intPt, int segmentIndex) Adds an intersection node for a given point and segment to this segment string.NodedSegmentString.addIntersectionNode
(Coordinate intPt, int segmentIndex) Adds an intersection node for a given point and segment to this segment string.private void
NodingValidator.checkCollapse
(Coordinate p0, Coordinate p1, Coordinate p2) private void
NodingValidator.checkEndPtVertexIntersections
(Coordinate testPt, Collection segStrings) static int
SegmentPointComparator.compare
(int octant, Coordinate p0, Coordinate p1) Compares twoCoordinate
s for their relative position along a segment lying in the specifiedOctant
.private static int
OrientedCoordinateArray.compareOriented
(Coordinate[] pts1, boolean orientation1, Coordinate[] pts2, boolean orientation2) private boolean
NodingValidator.hasInteriorIntersection
(LineIntersector li, Coordinate p0, Coordinate p1) static int
Octant.octant
(Coordinate p0, Coordinate p1) Returns the octant of a directed line segment from p0 to p1.private static boolean
OrientedCoordinateArray.orientation
(Coordinate[] pts) Computes the canonical orientation for a coordinate array.private void
ScaledNoder.rescale
(Coordinate[] pts) private int
NodedSegmentString.safeOctant
(Coordinate p0, Coordinate p1) private Coordinate[]
ScaledNoder.scale
(Coordinate[] pts) Constructors in org.locationtech.jts.noding with parameters of type CoordinateModifierConstructorDescriptionBasicSegmentString
(Coordinate[] pts, Object data) Creates a new segment string from a list of vertices.NodedSegmentString
(Coordinate[] pts, Object data) Creates a new segment string from a list of vertices.Creates a newOrientedCoordinateArray
for the givenCoordinate
array.SegmentNode
(NodedSegmentString segString, Coordinate coord, int segmentIndex, int segmentOctant) -
Uses of Coordinate in org.locationtech.jts.noding.snapround
Fields in org.locationtech.jts.noding.snapround declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate[]
HotPixel.corner
The corners of the hot pixel, in the order: 10 23private Coordinate
HotPixel.originalPt
private Coordinate
HotPixel.p0Scaled
private Coordinate
HotPixel.p1Scaled
private Coordinate
HotPixel.pt
private Coordinate
HotPixel.ptScaled
Methods in org.locationtech.jts.noding.snapround that return CoordinateModifier and TypeMethodDescriptionHotPixel.getCoordinate()
Gets the coordinate this hot pixel is based at.Methods in org.locationtech.jts.noding.snapround with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
HotPixel.copyScaled
(Coordinate p, Coordinate pScaled) private void
HotPixel.initCorners
(Coordinate pt) boolean
HotPixel.intersects
(Coordinate p0, Coordinate p1) Tests whether the line segment (p0-p1) intersects this hot pixel.private boolean
HotPixel.intersectsPixelClosure
(Coordinate p0, Coordinate p1) Test whether the given segment intersects the closure of this hot pixel.private boolean
HotPixel.intersectsScaled
(Coordinate p0, Coordinate p1) private boolean
HotPixel.intersectsToleranceSquare
(Coordinate p0, Coordinate p1) Tests whether the segment p0-p1 intersects the hot pixel tolerance square.Constructors in org.locationtech.jts.noding.snapround with parameters of type CoordinateModifierConstructorDescriptionHotPixel
(Coordinate pt, double scaleFactor, LineIntersector li) Creates a new hot pixel, using a given scale factor. -
Uses of Coordinate in org.locationtech.jts.operation
Fields in org.locationtech.jts.operation declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
IsSimpleOp.nonSimpleLocation
(package private) Coordinate
IsSimpleOp.EndpointInfo.pt
Methods in org.locationtech.jts.operation that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate[]
BoundaryOp.computeBoundaryCoordinates
(MultiLineString mLine) IsSimpleOp.EndpointInfo.getCoordinate()
IsSimpleOp.getNonSimpleLocation()
Gets a coordinate for the location where the geometry fails to be simple.Methods in org.locationtech.jts.operation with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
BoundaryOp.addEndpoint
(Coordinate pt) private void
IsSimpleOp.addEndpoint
(Map endPoints, Coordinate p, boolean isClosed) Add an endpoint to the map, creating an entry for it if none existsConstructors in org.locationtech.jts.operation with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.operation.buffer
Fields in org.locationtech.jts.operation.buffer declared as CoordinateModifier and TypeFieldDescriptionprivate static final Coordinate[]
OffsetSegmentString.COORDINATE_ARRAY_TYPE
private Coordinate[]
BufferInputLineSimplifier.inputLine
private Coordinate
RightmostEdgeFinder.minCoord
private Coordinate
BufferSubgraph.rightMostCoord
private Coordinate
OffsetSegmentGenerator.s0
private Coordinate
OffsetSegmentGenerator.s1
private Coordinate
OffsetSegmentGenerator.s2
Methods in org.locationtech.jts.operation.buffer that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate[]
BufferInputLineSimplifier.collapseLine()
private static Coordinate[]
OffsetCurveBuilder.copyCoordinates
(Coordinate[] pts) RightmostEdgeFinder.getCoordinate()
OffsetSegmentGenerator.getCoordinates()
OffsetSegmentString.getCoordinates()
OffsetCurveBuilder.getLineCurve
(Coordinate[] inputPts, double distance) This method handles single points as well as LineStrings.OffsetCurveBuilder.getOffsetCurve
(Coordinate[] inputPts, double distance) BufferSubgraph.getRightmostCoordinate()
Gets the rightmost coordinate in the edges of the subgraphOffsetCurveBuilder.getRingCurve
(Coordinate[] inputPts, int side, double distance) This method handles the degenerate cases of single points and lines, as well as rings.BufferInputLineSimplifier.simplify
(double distanceTol) Simplify the input coordinate list.static Coordinate[]
BufferInputLineSimplifier.simplify
(Coordinate[] inputLine, double distanceTol) Simplify the input coordinate list.Methods in org.locationtech.jts.operation.buffer with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
OffsetSegmentGenerator.addCornerFillet
(Coordinate p, Coordinate p0, Coordinate p1, int direction, double radius) Add points for a circular fillet around a reflex corner.private void
OffsetCurveSetBuilder.addCurve
(Coordinate[] coord, int leftLoc, int rightLoc) Creates aSegmentString
for a coordinate list which is a raw offset curve, and adds it to the list of buffer curves.private void
OffsetSegmentGenerator.addDirectedFillet
(Coordinate p, double startAngle, double endAngle, int direction, double radius) Adds points for a circular fillet arc between two specified angles.void
OffsetSegmentGenerator.addLineEndCap
(Coordinate p0, Coordinate p1) Add an end cap around point p1, terminating a line segment coming from p0private void
OffsetSegmentGenerator.addMitreJoin
(Coordinate p, LineSegment offset0, LineSegment offset1, double distance) Adds a mitre join connecting the two reflex offset segments.void
OffsetSegmentGenerator.addNextSegment
(Coordinate p, boolean addStartPoint) private void
OffsetCurveSetBuilder.addPolygonRing
(Coordinate[] coord, double offsetDistance, int side, int cwLeftLoc, int cwRightLoc) Adds an offset curve for a polygon ring.void
OffsetSegmentString.addPt
(Coordinate pt) void
OffsetSegmentString.addPts
(Coordinate[] pt, boolean isForward) void
OffsetSegmentGenerator.addSegments
(Coordinate[] pt, boolean isForward) private void
OffsetCurveBuilder.computeLineBufferCurve
(Coordinate[] inputPts, OffsetSegmentGenerator segGen) private void
OffsetCurveBuilder.computeOffsetCurve
(Coordinate[] inputPts, boolean isRightSide, OffsetSegmentGenerator segGen) private void
OffsetCurveBuilder.computePointCurve
(Coordinate pt, OffsetSegmentGenerator segGen) private void
OffsetCurveBuilder.computeRingBufferCurve
(Coordinate[] inputPts, int side, OffsetSegmentGenerator segGen) private void
OffsetCurveBuilder.computeSingleSidedBufferCurve
(Coordinate[] inputPts, boolean isRightSide, OffsetSegmentGenerator segGen) private static Coordinate[]
OffsetCurveBuilder.copyCoordinates
(Coordinate[] pts) void
OffsetSegmentGenerator.createCircle
(Coordinate p) Creates a CW circle around a pointvoid
OffsetSegmentGenerator.createSquare
(Coordinate p) Creates a CW square around a pointprivate List
SubgraphDepthLocater.findStabbedSegments
(Coordinate stabbingRayLeftPt) Finds all non-horizontal segments intersecting the stabbing line.private void
SubgraphDepthLocater.findStabbedSegments
(Coordinate stabbingRayLeftPt, List dirEdges, List stabbedSegments) Finds all non-horizontal segments intersecting the stabbing line in the list of dirEdges.private void
SubgraphDepthLocater.findStabbedSegments
(Coordinate stabbingRayLeftPt, DirectedEdge dirEdge, List stabbedSegments) Finds all non-horizontal segments intersecting the stabbing line in the input dirEdge.int
SubgraphDepthLocater.getDepth
(Coordinate p) OffsetCurveBuilder.getLineCurve
(Coordinate[] inputPts, double distance) This method handles single points as well as LineStrings.OffsetCurveBuilder.getOffsetCurve
(Coordinate[] inputPts, double distance) OffsetCurveBuilder.getRingCurve
(Coordinate[] inputPts, int side, double distance) This method handles the degenerate cases of single points and lines, as well as rings.void
OffsetSegmentGenerator.initSideSegments
(Coordinate s1, Coordinate s2, int side) private boolean
BufferInputLineSimplifier.isConcave
(Coordinate p0, Coordinate p1, Coordinate p2) private boolean
OffsetSegmentString.isRedundant
(Coordinate pt) Tests whether the given point is redundant relative to the previous point in the list (up to tolerance).private boolean
BufferInputLineSimplifier.isShallow
(Coordinate p0, Coordinate p1, Coordinate p2, double distanceTol) private boolean
BufferInputLineSimplifier.isShallowConcavity
(Coordinate p0, Coordinate p1, Coordinate p2, double distanceTol) private boolean
BufferInputLineSimplifier.isShallowSampled
(Coordinate p0, Coordinate p2, int i0, int i2, double distanceTol) Checks for shallowness over a sample of points in the given section.private boolean
OffsetCurveSetBuilder.isTriangleErodedCompletely
(Coordinate[] triangleCoord, double bufferDistance) Tests whether a triangular ring would be eroded completely by the given buffer distance.static Coordinate[]
BufferInputLineSimplifier.simplify
(Coordinate[] inputLine, double distanceTol) Simplify the input coordinate list.Constructors in org.locationtech.jts.operation.buffer with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.operation.buffer.validate
Fields in org.locationtech.jts.operation.buffer.validate declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
BufferDistanceValidator.errorLocation
private Coordinate
BufferResultValidator.errorLocation
private Coordinate[]
PointPairDistance.pt
Methods in org.locationtech.jts.operation.buffer.validate that return CoordinateModifier and TypeMethodDescriptionPointPairDistance.getCoordinate
(int i) PointPairDistance.getCoordinates()
BufferDistanceValidator.getErrorLocation()
BufferResultValidator.getErrorLocation()
Methods in org.locationtech.jts.operation.buffer.validate with parameters of type CoordinateModifier and TypeMethodDescriptionstatic void
DistanceToPointFinder.computeDistance
(Geometry geom, Coordinate pt, PointPairDistance ptDist) static void
DistanceToPointFinder.computeDistance
(LineSegment segment, Coordinate pt, PointPairDistance ptDist) static void
DistanceToPointFinder.computeDistance
(LineString line, Coordinate pt, PointPairDistance ptDist) static void
DistanceToPointFinder.computeDistance
(Polygon poly, Coordinate pt, PointPairDistance ptDist) void
BufferCurveMaximumDistanceFinder.MaxPointDistanceFilter.filter
(Coordinate pt) void
PointPairDistance.initialize
(Coordinate p0, Coordinate p1) private void
PointPairDistance.initialize
(Coordinate p0, Coordinate p1, double distance) Initializes the points, avoiding recomputing the distance.void
PointPairDistance.setMaximum
(Coordinate p0, Coordinate p1) void
PointPairDistance.setMinimum
(Coordinate p0, Coordinate p1) -
Uses of Coordinate in org.locationtech.jts.operation.distance
Fields in org.locationtech.jts.operation.distance declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
FacetSequence.p0
private Coordinate
FacetSequence.p1
private Coordinate
FacetSequence.pt
private Coordinate
GeometryLocation.pt
private Coordinate
FacetSequence.q0
private Coordinate
FacetSequence.q1
private Coordinate
FacetSequence.seqPt
Methods in org.locationtech.jts.operation.distance that return CoordinateModifier and TypeMethodDescriptionDistanceOp.closestPoints()
Deprecated.renamed to nearestPointsstatic Coordinate[]
DistanceOp.closestPoints
(Geometry g0, Geometry g1) Deprecated.renamed to nearestPointsFacetSequence.getCoordinate
(int index) GeometryLocation.getCoordinate()
Returns theCoordinate
of this location.DistanceOp.nearestPoints()
Report the coordinates of the nearest points in the input geometries.static Coordinate[]
DistanceOp.nearestPoints
(Geometry g0, Geometry g1) Compute the the nearest points of two geometries.Methods in org.locationtech.jts.operation.distance with parameters of type CoordinateModifier and TypeMethodDescriptionprivate double
FacetSequence.computePointLineDistance
(Coordinate pt, FacetSequence facetSeq) Constructors in org.locationtech.jts.operation.distance with parameters of type CoordinateModifierConstructorDescriptionGeometryLocation
(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. -
Uses of Coordinate in org.locationtech.jts.operation.distance3d
Methods in org.locationtech.jts.operation.distance3d that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate
PlanarPolygon3D.averagePoint
(CoordinateSequence seq) Computes a point which is the average of all coordinates in a sequence.AxisPlaneCoordinateSequence.getCoordinate
(int i) AxisPlaneCoordinateSequence.getCoordinateCopy
(int i) private Coordinate
Distance3DOp.intersection
(PlanarPolygon3D poly, LineString line) Distance3DOp.nearestPoints()
Report the coordinates of the nearest points in the input geometries.static Coordinate[]
Distance3DOp.nearestPoints
(Geometry g0, Geometry g1) Compute the the nearest points of two geometries.private static Coordinate
PlanarPolygon3D.project
(Coordinate p, int facingPlane) private static Coordinate
Distance3DOp.segmentPoint
(Coordinate p0, Coordinate p1, double d0, double d1) Computes a point at a distance along a segment specified by two relatively proportional values.AxisPlaneCoordinateSequence.toCoordinateArray()
Methods in org.locationtech.jts.operation.distance3d with parameters of type CoordinateModifier and TypeMethodDescriptionvoid
AxisPlaneCoordinateSequence.getCoordinate
(int index, Coordinate coord) boolean
PlanarPolygon3D.intersects
(Coordinate intPt) boolean
PlanarPolygon3D.intersects
(Coordinate pt, LineString ring) private int
PlanarPolygon3D.locate
(Coordinate pt, LineString ring) private static Coordinate
PlanarPolygon3D.project
(Coordinate p, int facingPlane) private static Coordinate
Distance3DOp.segmentPoint
(Coordinate p0, Coordinate p1, double d0, double d1) Computes a point at a distance along a segment specified by two relatively proportional values. -
Uses of Coordinate in org.locationtech.jts.operation.linemerge
Fields in org.locationtech.jts.operation.linemerge declared as CoordinateMethods in org.locationtech.jts.operation.linemerge that return CoordinateMethods in org.locationtech.jts.operation.linemerge with parameters of type CoordinateConstructors in org.locationtech.jts.operation.linemerge with parameters of type CoordinateModifierConstructorDescriptionLineMergeDirectedEdge
(Node from, Node to, Coordinate directionPt, boolean edgeDirection) Constructs a LineMergeDirectedEdge connecting thefrom
node to theto
node. -
Uses of Coordinate in org.locationtech.jts.operation.overlay
Methods in org.locationtech.jts.operation.overlay with parameters of type CoordinateModifier and TypeMethodDescriptionboolean
PolygonBuilder.containsPoint
(Coordinate p) Checks the current set of shells (with their associated holes) to see if any of them contain the point.OverlayNodeFactory.createNode
(Coordinate coord) private boolean
OverlayOp.isCovered
(Coordinate coord, List geomList) boolean
OverlayOp.isCoveredByA
(Coordinate coord) Tests if an L edge should be included in the result or not.boolean
OverlayOp.isCoveredByLA
(Coordinate coord) Tests if a point node should be included in the result or not. -
Uses of Coordinate in org.locationtech.jts.operation.overlay.snap
Fields in org.locationtech.jts.operation.overlay.snap declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate[]
SnapTransformer.snapPts
private Coordinate[]
LineStringSnapper.srcPts
Methods in org.locationtech.jts.operation.overlay.snap that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate[]
GeometrySnapper.extractTargetCoordinates
(Geometry g) private Coordinate
LineStringSnapper.findSnapForVertex
(Coordinate pt, Coordinate[] snapPts) private Coordinate[]
SnapTransformer.snapLine
(Coordinate[] srcPts, Coordinate[] snapPts) LineStringSnapper.snapTo
(Coordinate[] snapPts) Snaps the vertices and segments of the source LineString to the given set of snap vertices.Methods in org.locationtech.jts.operation.overlay.snap with parameters of type CoordinateModifier and TypeMethodDescriptionprivate double
GeometrySnapper.computeMinimumSegmentLength
(Coordinate[] pts) private double
GeometrySnapper.computeSnapTolerance
(Coordinate[] ringPts) Computes the snap tolerance based on the input geometries.private int
LineStringSnapper.findSegmentIndexToSnap
(Coordinate snapPt, CoordinateList srcCoords) Finds a src segment which snaps to (is close to) the given snap point.private Coordinate
LineStringSnapper.findSnapForVertex
(Coordinate pt, Coordinate[] snapPts) private static boolean
LineStringSnapper.isClosed
(Coordinate[] pts) private Coordinate[]
SnapTransformer.snapLine
(Coordinate[] srcPts, Coordinate[] snapPts) private void
LineStringSnapper.snapSegments
(CoordinateList srcCoords, Coordinate[] snapPts) Snap segments of the source to nearby snap vertices.LineStringSnapper.snapTo
(Coordinate[] snapPts) Snaps the vertices and segments of the source LineString to the given set of snap vertices.private void
LineStringSnapper.snapVertices
(CoordinateList srcCoords, Coordinate[] snapPts) Snap source vertices to vertices in the target.Constructors in org.locationtech.jts.operation.overlay.snap with parameters of type CoordinateModifierConstructorDescriptionLineStringSnapper
(Coordinate[] srcPts, double snapTolerance) Creates a new snapper using the given points as source points to be snapped.(package private)
SnapTransformer
(double snapTolerance, Coordinate[] snapPts) (package private)
SnapTransformer
(double snapTolerance, Coordinate[] snapPts, boolean isSelfSnap) -
Uses of Coordinate in org.locationtech.jts.operation.overlay.validate
Fields in org.locationtech.jts.operation.overlay.validate declared as CoordinateMethods in org.locationtech.jts.operation.overlay.validate that return CoordinateMethods in org.locationtech.jts.operation.overlay.validate with parameters of type CoordinateModifier and TypeMethodDescriptionprivate boolean
OverlayResultValidator.checkValid
(int overlayOp, Coordinate pt) private void
OffsetPointGenerator.computeOffsetPoints
(Coordinate p0, Coordinate p1, double offsetDistance, List offsetPts) Generates the two points which are offset from the midpoint of the segment (p0, p1) by the offsetDistance.int
FuzzyPointLocator.getLocation
(Coordinate pt) private boolean
FuzzyPointLocator.isWithinToleranceOfBoundary
(Coordinate pt) -
Uses of Coordinate in org.locationtech.jts.operation.polygonize
Fields in org.locationtech.jts.operation.polygonize declared as CoordinateMethods in org.locationtech.jts.operation.polygonize that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate[]
EdgeRing.getCoordinates()
Computes the list of coordinates which are contained in this ring.static Coordinate
EdgeRing.ptNotInList
(Coordinate[] testPts, Coordinate[] pts) Deprecated.Use CoordinateArrays.ptNotInList insteadMethods in org.locationtech.jts.operation.polygonize with parameters of type CoordinateModifier and TypeMethodDescriptionprivate static void
EdgeRing.addEdge
(Coordinate[] coords, boolean isForward, CoordinateList coordList) private Node
PolygonizeGraph.getNode
(Coordinate pt) static boolean
EdgeRing.isInList
(Coordinate pt, Coordinate[] pts) Deprecated.static Coordinate
EdgeRing.ptNotInList
(Coordinate[] testPts, Coordinate[] pts) Deprecated.Use CoordinateArrays.ptNotInList insteadConstructors in org.locationtech.jts.operation.polygonize with parameters of type CoordinateModifierConstructorDescriptionPolygonizeDirectedEdge
(Node from, Node to, Coordinate directionPt, boolean edgeDirection) Constructs a directed edge connecting thefrom
node to theto
node. -
Uses of Coordinate in org.locationtech.jts.operation.predicate
Fields in org.locationtech.jts.operation.predicate declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
RectangleIntersectsSegmentVisitor.p0
private Coordinate
RectangleIntersectsSegmentVisitor.p1
Methods in org.locationtech.jts.operation.predicate with parameters of type CoordinateModifier and TypeMethodDescriptionprivate boolean
RectangleContains.isLineSegmentContainedInBoundary
(Coordinate p0, Coordinate p1) Tests if a line segment is contained in the boundary of the target rectangle.private boolean
RectangleContains.isPointContainedInBoundary
(Coordinate pt) Tests if a point is contained in the boundary of the target rectangle. -
Uses of Coordinate in org.locationtech.jts.operation.relate
Fields in org.locationtech.jts.operation.relate declared as CoordinateMethods in org.locationtech.jts.operation.relate with parameters of type CoordinateConstructors in org.locationtech.jts.operation.relate with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.operation.valid
Fields in org.locationtech.jts.operation.valid declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
ConnectedInteriorTester.disconnectedRingcoord
private Coordinate
ConsistentAreaTester.invalidPoint
private Coordinate
IndexedNestedRingTester.nestedPt
private Coordinate
TopologyValidationError.pt
private Coordinate
RepeatedPointTester.repeatedCoord
Methods in org.locationtech.jts.operation.valid that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate
IsValidOp.checkShellInsideHole
(LinearRing shell, LinearRing hole, GeometryGraph graph) This routine checks to see if a shell is properly contained in a hole.static Coordinate
ConnectedInteriorTester.findDifferentPoint
(Coordinate[] coord, Coordinate pt) static Coordinate
IsValidOp.findPtNotNode
(Coordinate[] testCoords, LinearRing searchRing, GeometryGraph graph) Find a point from the list of testCoords that is NOT a node in the edge for the list of searchCoordsConnectedInteriorTester.getCoordinate()
RepeatedPointTester.getCoordinate()
TopologyValidationError.getCoordinate()
Returns the location of this error (on theGeometry
containing the error).ConsistentAreaTester.getInvalidPoint()
IndexedNestedRingTester.getNestedPoint()
Methods in org.locationtech.jts.operation.valid with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
IsValidOp.checkInvalidCoordinates
(Coordinate[] coords) static Coordinate
ConnectedInteriorTester.findDifferentPoint
(Coordinate[] coord, Coordinate pt) static Coordinate
IsValidOp.findPtNotNode
(Coordinate[] testCoords, LinearRing searchRing, GeometryGraph graph) Find a point from the list of testCoords that is NOT a node in the edge for the list of searchCoordsboolean
RepeatedPointTester.hasRepeatedPoint
(Coordinate[] coord) static boolean
IsValidOp.isValid
(Coordinate coord) Checks whether a coordinate is valid for processing.Constructors in org.locationtech.jts.operation.valid with parameters of type CoordinateModifierConstructorDescriptionTopologyValidationError
(int errorType, Coordinate pt) Creates a validation error with the given type and location -
Uses of Coordinate in org.locationtech.jts.planargraph
Fields in org.locationtech.jts.planargraph declared as CoordinateModifier and TypeFieldDescriptionprotected Coordinate
DirectedEdge.p0
protected Coordinate
DirectedEdge.p1
protected Coordinate
Node.pt
The location of this NodeMethods in org.locationtech.jts.planargraph that return CoordinateModifier and TypeMethodDescriptionDirectedEdge.getCoordinate()
Returns the coordinate of the from-node.DirectedEdgeStar.getCoordinate()
Returns the coordinate for the node at which this star is basedNode.getCoordinate()
Returns the location of this Node.DirectedEdge.getDirectionPt()
Returns a point to which an imaginary line is drawn from the from-node to specify this DirectedEdge's orientation.Methods in org.locationtech.jts.planargraph with parameters of type CoordinateModifier and TypeMethodDescriptionNodeMap.find
(Coordinate coord) Returns the Node at the given location, or null if no Node was there.PlanarGraph.findNode
(Coordinate pt) NodeMap.remove
(Coordinate pt) Removes the Node at the given location, and returns it (or null if no Node was there).Constructors in org.locationtech.jts.planargraph with parameters of type CoordinateModifierConstructorDescriptionDirectedEdge
(Node from, Node to, Coordinate directionPt, boolean edgeDirection) Constructs a DirectedEdge connecting thefrom
node to theto
node.Node
(Coordinate pt) Constructs a Node with the given location.Node
(Coordinate pt, DirectedEdgeStar deStar) Constructs a Node with the given location and collection of outgoing DirectedEdges. -
Uses of Coordinate in org.locationtech.jts.precision
Fields in org.locationtech.jts.precision declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
CommonBitsRemover.commonCoord
private Coordinate[]
MinimumClearance.minClearancePts
private Coordinate[]
SimpleMinimumClearance.minClearancePts
private Coordinate[]
MinimumClearance.MinClearanceDistance.minPts
private Coordinate
SimpleMinimumClearance.ComputeMCCoordinateSequenceFilter.queryPt
(package private) Coordinate
CommonBitsRemover.Translater.trans
Methods in org.locationtech.jts.precision that return CoordinateModifier and TypeMethodDescriptionPrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) SimpleGeometryPrecisionReducer.PrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) CommonBitsRemover.CommonCoordinateFilter.getCommonCoordinate()
CommonBitsRemover.getCommonCoordinate()
The common bits of the Coordinates in the supplied Geometries.MinimumClearance.MinClearanceDistance.getCoordinates()
Methods in org.locationtech.jts.precision with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
SimpleMinimumClearance.ComputeMCCoordinateSequenceFilter.checkSegmentDistance
(Coordinate seg0, Coordinate seg1) private void
SimpleMinimumClearance.ComputeMCCoordinateSequenceFilter.checkVertexDistance
(Coordinate vertex) PrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) SimpleGeometryPrecisionReducer.PrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) void
CommonBitsRemover.CommonCoordinateFilter.filter
(Coordinate coord) void
SimpleMinimumClearance.VertexCoordinateFilter.filter
(Coordinate coord) private void
SimpleMinimumClearance.updateClearance
(double candidateValue, Coordinate p0, Coordinate p1) private void
SimpleMinimumClearance.updateClearance
(double candidateValue, Coordinate p, Coordinate seg0, Coordinate seg1) private void
MinimumClearance.MinClearanceDistance.updatePts
(Coordinate p, Coordinate seg0, Coordinate seg1) Constructors in org.locationtech.jts.precision with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.shape
Methods in org.locationtech.jts.shape that return CoordinateModifier and TypeMethodDescriptionprotected Coordinate
GeometricShapeBuilder.createCoord
(double x, double y) GeometricShapeBuilder.getCentre()
-
Uses of Coordinate in org.locationtech.jts.shape.fractal
Methods in org.locationtech.jts.shape.fractal that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate[]
KochSnowflakeBuilder.getBoundary
(int level, Coordinate origin, double width) Methods in org.locationtech.jts.shape.fractal with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
KochSnowflakeBuilder.addSegment
(Coordinate p0, Coordinate p1) void
KochSnowflakeBuilder.addSide
(int level, Coordinate p0, Coordinate p1) private Coordinate[]
KochSnowflakeBuilder.getBoundary
(int level, Coordinate origin, double width) -
Uses of Coordinate in org.locationtech.jts.shape.random
Methods in org.locationtech.jts.shape.random that return CoordinateModifier and TypeMethodDescriptionprotected Coordinate
RandomPointsBuilder.createCoord
(double x, double y) protected Coordinate
RandomPointsBuilder.createRandomCoord
(Envelope env) private Coordinate
RandomPointsInGridBuilder.randomPointInCell
(double orgX, double orgY, double xLen, double yLen) private static Coordinate
RandomPointsInGridBuilder.randomPointInCircle
(double orgX, double orgY, double width, double height) private Coordinate
RandomPointsInGridBuilder.randomPointInGridCell
(double orgX, double orgY, double xLen, double yLen) Methods in org.locationtech.jts.shape.random with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.simplify
Fields in org.locationtech.jts.simplify declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate[]
TaggedLineStringSimplifier.linePts
private Coordinate
VWLineSimplifier.VWVertex.pt
private Coordinate[]
DouglasPeuckerLineSimplifier.pts
private Coordinate[]
VWLineSimplifier.pts
Methods in org.locationtech.jts.simplify that return CoordinateModifier and TypeMethodDescriptionprivate static Coordinate[]
TaggedLineString.extractCoordinates
(List segs) VWLineSimplifier.VWVertex.getCoordinates()
TaggedLineString.getParentCoordinates()
TaggedLineString.getResultCoordinates()
DouglasPeuckerLineSimplifier.simplify()
static Coordinate[]
DouglasPeuckerLineSimplifier.simplify
(Coordinate[] pts, double distanceTolerance) VWLineSimplifier.simplify()
static Coordinate[]
VWLineSimplifier.simplify
(Coordinate[] pts, double distanceTolerance) Methods in org.locationtech.jts.simplify with parameters of type CoordinateModifier and TypeMethodDescriptionstatic VWLineSimplifier.VWVertex
VWLineSimplifier.VWVertex.buildLine
(Coordinate[] pts) private int
TaggedLineStringSimplifier.findFurthestPoint
(Coordinate[] pts, int i, int j, double[] maxDistance) static Coordinate[]
DouglasPeuckerLineSimplifier.simplify
(Coordinate[] pts, double distanceTolerance) static Coordinate[]
VWLineSimplifier.simplify
(Coordinate[] pts, double distanceTolerance) Constructors in org.locationtech.jts.simplify with parameters of type CoordinateModifierConstructorDescriptionTaggedLineSegment
(Coordinate p0, Coordinate p1) TaggedLineSegment
(Coordinate p0, Coordinate p1, Geometry parent, int index) VWLineSimplifier
(Coordinate[] pts, double distanceTolerance) VWVertex
(Coordinate pt) -
Uses of Coordinate in org.locationtech.jts.triangulate
Fields in org.locationtech.jts.triangulate declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
ConstraintEnforcementException.pt
private Coordinate
ConformingDelaunayTriangulator.splitPt
private Coordinate
SplitSegment.splitPt
Methods in org.locationtech.jts.triangulate that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate
ConformingDelaunayTriangulator.findNonGabrielPoint
(Segment seg) Given a set of points stored in the kd-tree and a line segment defined by two points in this set, finds aCoordinate
in the circumcircle of the line segment, if one exists.ConstraintSplitPointFinder.findSplitPoint
(Segment seg, Coordinate encroachPt) Finds a point at which to split an encroached segment to allow the original segment to appear as edges in a constrained Delaunay triangulation.MidpointSplitPointFinder.findSplitPoint
(Segment seg, Coordinate encroachPt) Gets the midpoint of the split segmentNonEncroachingSplitPointFinder.findSplitPoint
(Segment seg, Coordinate encroachPt) A basic strategy for finding split points when nothing extra is known about the geometry of the situation.ConstraintEnforcementException.getCoordinate()
Gets the approximate location of this error.Segment.getEnd()
Gets the end coordinate of the segmentprivate Coordinate[]
ConformingDelaunayTriangulator.getPointArray()
SplitSegment.getSplitPoint()
Segment.getStart()
Gets the start coordinate of the segmentSegment.intersection
(Segment s) Computes the intersection point between this segment and another one.private static Coordinate
SplitSegment.pointAlongReverse
(LineSegment seg, double segmentLengthFraction) Computes theCoordinate
that lies a given fraction along the line defined by the reverse of the given segment.static Coordinate
NonEncroachingSplitPointFinder.projectedSplitPoint
(Segment seg, Coordinate encroachPt) Computes a split point which is the projection of the encroaching point on the segmentMethods in org.locationtech.jts.triangulate with parameters of type CoordinateModifier and TypeMethodDescriptionprivate ConstraintVertex
ConformingDelaunayTriangulator.createVertex
(Coordinate p) private ConstraintVertex
ConformingDelaunayTriangulator.createVertex
(Coordinate p, Segment seg) Creates a vertex on a constraint segmentConstraintVertexFactory.createVertex
(Coordinate p, Segment constraintSeg) ConstraintSplitPointFinder.findSplitPoint
(Segment seg, Coordinate encroachPt) Finds a point at which to split an encroached segment to allow the original segment to appear as edges in a constrained Delaunay triangulation.MidpointSplitPointFinder.findSplitPoint
(Segment seg, Coordinate encroachPt) Gets the midpoint of the split segmentNonEncroachingSplitPointFinder.findSplitPoint
(Segment seg, Coordinate encroachPt) A basic strategy for finding split points when nothing extra is known about the geometry of the situation.void
ConformingDelaunayTriangulator.insertSite
(Coordinate p) Inserts a site into the triangulation, maintaining the conformal Delaunay property.private void
VertexTaggedGeometryDataMapper.loadVertices
(Coordinate[] pts, Object data) private static String
ConstraintEnforcementException.msgWithCoord
(String msg, Coordinate pt) static Coordinate
NonEncroachingSplitPointFinder.projectedSplitPoint
(Segment seg, Coordinate encroachPt) Computes a split point which is the projection of the encroaching point on the segmentvoid
SplitSegment.splitAt
(double length, Coordinate endPt) void
SplitSegment.splitAt
(Coordinate pt) static CoordinateList
DelaunayTriangulationBuilder.unique
(Coordinate[] coords) Constructors in org.locationtech.jts.triangulate with parameters of type CoordinateModifierConstructorDescriptionCreates a new instance with a given message and approximate location.Creates a new constraint vertexSegment
(Coordinate p0, Coordinate p1) Creates a new instance for the given points.Segment
(Coordinate p0, Coordinate p1, Object data) Creates a new instance for the given points, with associated external data. -
Uses of Coordinate in org.locationtech.jts.triangulate.quadedge
Fields in org.locationtech.jts.triangulate.quadedge declared as CoordinateMethods in org.locationtech.jts.triangulate.quadedge that return CoordinateModifier and TypeMethodDescriptionQuadEdgeTriangle.getCoordinate
(int i) Vertex.getCoordinate()
QuadEdgeTriangle.getCoordinates()
Methods in org.locationtech.jts.triangulate.quadedge with parameters of type CoordinateModifier and TypeMethodDescriptionprivate static void
TrianglePredicate.checkRobustInCircle
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) Checks if the computed value for isInCircle is correct, using double-double precision arithmetic.private void
QuadEdgeSubdivision.TriangleCoordinatesVisitor.checkTriangleSize
(Coordinate[] pts) boolean
QuadEdgeTriangle.contains
(Coordinate pt) static boolean
QuadEdgeTriangle.contains
(QuadEdge[] tri, Coordinate pt) Tests whether the point pt is contained in the triangle defined by 3QuadEdge
es.static boolean
QuadEdgeTriangle.contains
(Vertex[] tri, Coordinate pt) Tests whether the point pt is contained in the triangle defined by 3Vertex
es.static double
Vertex.interpolateZ
(Coordinate p, Coordinate p0, Coordinate p1) Computes the interpolated Z-value for a point p lying on the segment p0-p1static double
Vertex.interpolateZ
(Coordinate p, Coordinate v0, Coordinate v1, Coordinate v2) Interpolates the Z-value (height) of a point enclosed in a triangle whose vertices all have Z values.static boolean
TrianglePredicate.isInCircleCC
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) Computes the inCircle test using distance from the circumcentre.static boolean
TrianglePredicate.isInCircleDDFast
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) static boolean
TrianglePredicate.isInCircleDDNormalized
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) static boolean
TrianglePredicate.isInCircleDDSlow
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) Tests if a point is inside the circle defined by the triangle with vertices a, b, c (oriented counter-clockwise).static boolean
TrianglePredicate.isInCircleNonRobust
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) Tests if a point is inside the circle defined by the triangle with vertices a, b, c (oriented counter-clockwise).static boolean
TrianglePredicate.isInCircleNormalized
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) Tests if a point is inside the circle defined by the triangle with vertices a, b, c (oriented counter-clockwise).static boolean
TrianglePredicate.isInCircleRobust
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) Tests if a point is inside the circle defined by the triangle with vertices a, b, c (oriented counter-clockwise).boolean
QuadEdgeSubdivision.isOnEdge
(QuadEdge e, Coordinate p) Tests whether aCoordinate
lies on aQuadEdge
, up to a tolerance determined by the subdivision tolerance.QuadEdgeSubdivision.locate
(Coordinate p) Finds a quadedge of a triangle containing a location specified by aCoordinate
, if one exists.QuadEdgeSubdivision.locate
(Coordinate p0, Coordinate p1) Locates the edge between the given vertices, if it exists in the subdivision.private static double
TrianglePredicate.triArea
(Coordinate a, Coordinate b, Coordinate c) Computes twice the area of the oriented triangle (a, b, c), i.e., the area is positive if the triangle is oriented counterclockwise.static DD
TrianglePredicate.triAreaDDFast
(Coordinate a, Coordinate b, Coordinate c) Constructors in org.locationtech.jts.triangulate.quadedge with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.util
Fields in org.locationtech.jts.util declared as CoordinateModifier and TypeFieldDescriptionGeometricShapeFactory.Dimensions.base
GeometricShapeFactory.Dimensions.centre
private Coordinate
Debug.SegmentFindingFilter.p0
private Coordinate
Debug.SegmentFindingFilter.p1
(package private) Coordinate[]
CoordinateArrayFilter.pts
Methods in org.locationtech.jts.util that return CoordinateModifier and TypeMethodDescriptionprotected Coordinate
GeometricShapeFactory.coord
(double x, double y) protected Coordinate
GeometricShapeFactory.coordTrans
(double x, double y, Coordinate trans) static Coordinate[]
UniqueCoordinateArrayFilter.filterCoordinates
(Coordinate[] coords) Convenience method which allows running the filter over an array ofCoordinate
s.GeometricShapeFactory.Dimensions.getBase()
GeometricShapeFactory.Dimensions.getCentre()
CoordinateArrayFilter.getCoordinates()
Returns the gatheredCoordinate
s.UniqueCoordinateArrayFilter.getCoordinates()
Returns the gatheredCoordinate
s.Methods in org.locationtech.jts.util with parameters of type CoordinateModifier and TypeMethodDescriptionstatic void
Debug.breakIfEqual
(Coordinate p0, Coordinate p1, double tolerance) protected Coordinate
GeometricShapeFactory.coordTrans
(double x, double y, Coordinate trans) static boolean
Debug.equals
(Coordinate c1, Coordinate c2, double tolerance) void
CoordinateArrayFilter.filter
(Coordinate coord) void
CoordinateCountFilter.filter
(Coordinate coord) void
UniqueCoordinateArrayFilter.filter
(Coordinate coord) static Coordinate[]
UniqueCoordinateArrayFilter.filterCoordinates
(Coordinate[] coords) Convenience method which allows running the filter over an array ofCoordinate
s.static boolean
Debug.hasSegment
(Geometry geom, Coordinate p0, Coordinate p1) void
GeometricShapeFactory.Dimensions.setBase
(Coordinate base) void
GeometricShapeFactory.setBase
(Coordinate base) Sets the location of the shape by specifying the base coordinate (which in most cases is the lower left point of the envelope containing the shape).void
GeometricShapeFactory.Dimensions.setCentre
(Coordinate centre) void
GeometricShapeFactory.setCentre
(Coordinate centre) Sets the location of the shape by specifying the centre of the shape's bounding boxstatic LineString
Debug.toLine
(Coordinate p0, Coordinate p1) static LineString
Debug.toLine
(Coordinate p0, Coordinate p1, Coordinate p2) static LineString
Debug.toLine
(Coordinate p0, Coordinate p1, Coordinate p2, Coordinate p3) Constructors in org.locationtech.jts.util with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jtsexample.geom
Subclasses of Coordinate in org.locationtech.jtsexample.geomMethods in org.locationtech.jtsexample.geom that return CoordinateModifier and TypeMethodDescriptionExtendedCoordinateSequence.getCoordinate
(int i) ExtendedCoordinateSequence.getCoordinateCopy
(int index) ExtendedCoordinateSequence.toCoordinateArray()
Methods in org.locationtech.jtsexample.geom with parameters of type CoordinateModifier and TypeMethodDescriptionstatic ExtendedCoordinate[]
ExtendedCoordinateSequence.copy
(Coordinate[] coordinates) ExtendedCoordinateSequenceFactory.create
(Coordinate[] coordinates) Returns an ExtendedCoordinateSequence based on the given array -- the array is used directly if it is an instance of ExtendedCoordinate[]; otherwise it is copied.void
ExtendedCoordinateSequence.getCoordinate
(int index, Coordinate coord) Constructors in org.locationtech.jtsexample.geom with parameters of type CoordinateModifierConstructorDescriptionExtendedCoordinate
(Coordinate coord) ExtendedCoordinateSequence
(Coordinate[] copyCoords) Constructor that makes a copy of an array of Coordinates. -
Uses of Coordinate in org.locationtech.jtsexample.technique
Methods in org.locationtech.jtsexample.technique with parameters of type CoordinateModifier and TypeMethodDescription(package private) static Geometry
SearchUsingPreparedGeometryIndex.createCircle
(Coordinate centre, double radius) -
Uses of Coordinate in org.locationtech.jtstest.clean
Methods in org.locationtech.jtstest.clean that return CoordinateModifier and TypeMethodDescriptionstatic Coordinate[]
CleanDuplicatePoints.removeDuplicatePoints
(Coordinate[] coord) Methods in org.locationtech.jtstest.clean with parameters of type CoordinateModifier and TypeMethodDescriptionstatic Coordinate[]
CleanDuplicatePoints.removeDuplicatePoints
(Coordinate[] coord) -
Uses of Coordinate in org.locationtech.jtstest.function
Methods in org.locationtech.jtstest.function that return CoordinateModifier and TypeMethodDescriptionprivate static Coordinate
AffineTransformationFunctions.envelopeCentre
(Geometry g) private static Coordinate
AffineTransformationFunctions.envelopeLowerLeft
(Geometry g) (package private) static Coordinate[]
private static Coordinate
CreateRandomShapeFunctions.randomPointInTriangle
(Coordinate p0, Coordinate p1, Coordinate p2) private static Coordinate
CreateRandomShapeFunctions.randomPtInRectangleAround
(Coordinate centre, double width, double height) private static Coordinate[]
TriangleFunctions.trianglePts
(Geometry g) Methods in org.locationtech.jtstest.function with parameters of type CoordinateModifier and TypeMethodDescriptionprivate static Coordinate
CreateRandomShapeFunctions.randomPointInTriangle
(Coordinate p0, Coordinate p1, Coordinate p2) private static Coordinate
CreateRandomShapeFunctions.randomPtInRectangleAround
(Coordinate centre, double width, double height) -
Uses of Coordinate in org.locationtech.jtstest.geomop
Methods in org.locationtech.jtstest.geomop with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
BufferValidatedGeometryOperation.reportError
(String msg, Coordinate loc) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder
Fields in org.locationtech.jtstest.testbuilder declared as CoordinateModifier and TypeFieldDescription(package private) Coordinate
GeometryPopupMenu.clickCoord
(package private) Coordinate
CoordinateNode.coord
(package private) Coordinate
GeometryEditPanel.markPoint
private Coordinate
ValidPanel.markPoint
Methods in org.locationtech.jtstest.testbuilder that return CoordinateModifier and TypeMethodDescriptionValidPanel.getMarkPoint()
(package private) Coordinate
private Coordinate
JTSTestBuilderFrame.pickOffset
(Geometry a, Geometry b) Methods in org.locationtech.jtstest.testbuilder with parameters of type CoordinateModifier and TypeMethodDescriptionstatic CoordinateNode
CoordinateNode.create
(Coordinate p) static CoordinateNode
CoordinateNode.create
(Coordinate p, int i, double distPrev) void
JTSTestBuilderFrame.displayInfo
(Coordinate modelPt) private void
GeometryEditPanel.drawHighlightedVertex
(Graphics2D g, Coordinate pt, Color clr) private void
GeometryEditPanel.drawVertexShadow
(Graphics2D g, Coordinate pt, Color clr) GeometryEditPanel.getInfo
(Coordinate pt) private static String
CoordinateNode.label
(Coordinate coord, int i, double distPrev) private void
LineStringNode.populateChildren
(Coordinate[] pt) void
GeometryEditPanel.setHighlightPoint
(Coordinate pt) private void
ValidPanel.setMarkPoint
(Coordinate coord) Constructors in org.locationtech.jtstest.testbuilder with parameters of type CoordinateModifierConstructorDescriptionCoordinateNode
(Coordinate coord) CoordinateNode
(Coordinate coord, int i, double distPrev) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.controller
Methods in org.locationtech.jtstest.testbuilder.controller with parameters of type CoordinateModifier and TypeMethodDescriptionstatic void
JTSTestBuilderController.copyComponentToClipboard
(Coordinate pt) static void
JTSTestBuilderController.extractComponentsToTestCase
(Coordinate pt) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.geom
Fields in org.locationtech.jtstest.testbuilder.geom declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
AdjacentVertexFinder.AdjacentVertexFilter.basePt
private Coordinate
NearestPointFinder.NearestPointFilter.basePt
private Coordinate
VertexLocater.NearestVertexFilter.basePt
private Coordinate
GeometryVertexMover.MoveVertexOperation.fromLoc
private Coordinate
GeometryPointLocater.locationPt
private Coordinate
GeometryPointLocater.NearestSegmentLocationFilter.nearestPt
private Coordinate
NearestPointFinder.NearestPointFilter.nearestPt
private Coordinate
VertexLocater.NearestVertexFilter.nearestPt
private Coordinate
GeometryVertexDeleter.DeleteVertexOperation.newVertex
private Coordinate
GeometryVertexInserter.InsertVertexOperation.newVertex
private Coordinate
GeometryLocation.pt
The actual coordinate for the locationprivate Coordinate
VertexLocater.Location.pt
private Coordinate
FacetLocater.queryPt
private Coordinate
VertexLocater.NearVerticesFilter.queryPt
private Coordinate
GeometryPointLocater.NearestSegmentLocationFilter.testPt
private Coordinate
GeometryVertexMover.MoveVertexOperation.toLoc
private Coordinate
AdjacentVertexFinder.vertexPt
private Coordinate
VertexLocater.vertexPt
Methods in org.locationtech.jtstest.testbuilder.geom that return CoordinateModifier and TypeMethodDescriptionGeometryBoxDeleter.BoxDeleteVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexDeleter.DeleteVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexInserter.InsertVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexMover.MoveVertexOperation.edit
(Coordinate[] coords, Geometry geometry) static Coordinate
NearestPointFinder.findNearestPoint
(Geometry geom, Coordinate pt, double tolerance) static Coordinate[]
AdjacentVertexFinder.findVertices
(Geometry geom, Coordinate testPt) GeometryLocation.getCoordinate()
GeometryPointLocater.NearestSegmentLocationFilter.getCoordinate()
VertexLocater.Location.getCoordinate()
NearestPointFinder.getNearestPoint
(Coordinate pt, double tolerance) NearestPointFinder.NearestPointFilter.getNearestPoint()
VertexLocater.getVertex
(Coordinate testPt, double tolerance) VertexLocater.NearestVertexFilter.getVertex()
AdjacentVertexFinder.AdjacentVertexFilter.getVertices()
AdjacentVertexFinder.getVertices
(Coordinate testPt) static Coordinate
VertexLocater.locateVertex
(Geometry geom, Coordinate testPt, double tolerance) Methods in org.locationtech.jtstest.testbuilder.geom with parameters of type CoordinateModifier and TypeMethodDescriptionGeometryCombiner.addLineString
(Geometry orig, Coordinate[] pts) GeometryCombiner.addPoint
(Geometry orig, Coordinate pt) GeometryCombiner.addPolygonRing
(Geometry orig, Coordinate[] pts) private Geometry
ComponentLocater.createAOI
(Coordinate queryPt, double tolerance) GeometryBoxDeleter.BoxDeleteVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexDeleter.DeleteVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexInserter.InsertVertexOperation.edit
(Coordinate[] coords, Geometry geometry) GeometryVertexMover.MoveVertexOperation.edit
(Coordinate[] coords, Geometry geometry) static Coordinate
NearestPointFinder.findNearestPoint
(Geometry geom, Coordinate pt, double tolerance) private static Polygon
GeometryCombiner.findPolygonContaining
(Geometry geom, Coordinate pt) static Coordinate[]
AdjacentVertexFinder.findVertices
(Geometry geom, Coordinate testPt) ComponentLocater.getComponents
(Coordinate queryPt, double tolerance) GeometryPointLocater.getLocation
(Coordinate testPt, boolean vertexOnly, double tolerance) FacetLocater.getLocations
(Coordinate queryPt, double tolerance) VertexLocater.getLocations
(Coordinate testPt, double tolerance) NearestPointFinder.getNearestPoint
(Coordinate pt, double tolerance) VertexLocater.getVertex
(Coordinate testPt, double tolerance) AdjacentVertexFinder.getVertices
(Coordinate testPt) private boolean
GeometryBoxDeleter.BoxDeleteVertexOperation.hasVertexInBox
(Coordinate[] coords) static Geometry
GeometryVertexInserter.insert
(Geometry geom, LineString line, int segIndex, Coordinate newVertex) static GeometryLocation
GeometryPointLocater.locateNonVertexPoint
(Geometry geom, Coordinate testPt, double tolerance) static GeometryLocation
GeometryPointLocater.locateVertex
(Geometry geom, Coordinate testPt, double tolerance) static Coordinate
VertexLocater.locateVertex
(Geometry geom, Coordinate testPt, double tolerance) static Geometry
GeometryVertexMover.move
(Geometry geom, Coordinate fromLoc, Coordinate toLoc) Constructors in org.locationtech.jtstest.testbuilder.geom with parameters of type CoordinateModifierConstructorDescriptionAdjacentVertexFilter
(Coordinate basePt) 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) InsertVertexOperation
(LineString line, int segIndex, Coordinate newVertex) (package private)
Location
(Coordinate pt, int index) MoveVertexOperation
(Coordinate fromLoc, Coordinate toLoc) NearestPointFilter
(Coordinate basePt, double tolerance) NearestSegmentLocationFilter
(Coordinate testPt, boolean vertexOnly, double tolerance) NearestVertexFilter
(Coordinate basePt, double tolerance) NearVerticesFilter
(Coordinate queryPt, double tolerance) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.io.shapefile
Methods in org.locationtech.jtstest.testbuilder.io.shapefile with parameters of type CoordinateModifier and TypeMethodDescription(package private) boolean
PolygonHandler.pointInList
(Coordinate testPoint, Coordinate[] pointList) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.model
Methods in org.locationtech.jtstest.testbuilder.model that return CoordinateModifier and TypeMethodDescriptionGeometryEditModel.findAdjacentVertices
(Coordinate vertex) private static Coordinate[]
GeometryEditModel.locateVertexPt
(Coordinate testPt, double tolerance) Methods in org.locationtech.jtstest.testbuilder.model with parameters of type CoordinateModifier and TypeMethodDescriptionGeometryEditModel.findAdjacentVertices
(Coordinate vertex) LayerList.getComponent
(Coordinate pt, double tolerance) GeometryEditModel.locateNonVertexPoint
(Coordinate testPt, double tolerance) Locates a non-vertex point on a line segment of the current geometry within the given tolerance, if any.GeometryEditModel.locateVertex
(Coordinate testPt, double tolerance) Locates a vertex of the current geometry within the given tolerance, if any.GeometryEditModel.locateVertexPt
(Coordinate testPt, double tolerance) void
GeometryEditModel.moveVertex
(Coordinate fromLoc, Coordinate toLoc) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.topostretch
Fields in org.locationtech.jtstest.testbuilder.topostretch declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate
StretchedVertex.nearPt
private Coordinate[]
StretchedVertex.nearPts
private Coordinate[]
StretchedVertex.parentLine
private Coordinate
StretchedVertex.stretchedPt
private Coordinate
StretchedVertex.vertexPt
Methods in org.locationtech.jtstest.testbuilder.topostretch that return CoordinateModifier and TypeMethodDescriptionprivate Coordinate
StretchedVertex.displaceFromCorner
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) private Coordinate
StretchedVertex.displaceFromCornerAwayFromArms
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) Displaces a vertex from a corner, with angle limiting used to ensure that the displacement is not close to the arms of the corner.private Coordinate
StretchedVertex.displaceFromCornerOriginal
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) private Coordinate
StretchedVertex.displaceFromFlatCorner
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) private Coordinate
StretchedVertex.displaceFromPoint
(Coordinate nearPt, double dist) private Coordinate
StretchedVertex.displaceFromSeg
(LineSegment nearSeg, double dist) private Coordinate
StretchedVertex.displaceFromVertex
(Coordinate nearPt, double dist) GeometryVerticesMover.MoveVerticesOperation.edit
(Coordinate[] coords, Geometry geometry) private Coordinate
StretchedVertex.getNearRingPoint
(int i) StretchedVertex.getStretchedVertex
(double dist) Gets the point which this near vertex will be stretched to (by a given distance)StretchedVertex.getVertexCoordinate()
private Coordinate
GeometryVerticesMover.MoveVerticesOperation.movedPt
(Coordinate orig) private static Coordinate[]
StretchedVertex.orientCorner
(Coordinate p0, Coordinate p1, Coordinate p2) Returns an array of pts such that p0 - p[0] - [p1] is CW.private static Coordinate
StretchedVertex.rotateToQuadrant
(Coordinate v, int quadrant) Methods in org.locationtech.jtstest.testbuilder.topostretch with parameters of type CoordinateModifier and TypeMethodDescriptionprivate static boolean
StretchedVertexFinder.contains
(Envelope env, Coordinate p0, Coordinate p1) private Coordinate
StretchedVertex.displaceFromCorner
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) private Coordinate
StretchedVertex.displaceFromCornerAwayFromArms
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) Displaces a vertex from a corner, with angle limiting used to ensure that the displacement is not close to the arms of the corner.private Coordinate
StretchedVertex.displaceFromCornerOriginal
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) private Coordinate
StretchedVertex.displaceFromFlatCorner
(Coordinate nearPt, Coordinate p1, Coordinate p2, double dist) private Coordinate
StretchedVertex.displaceFromPoint
(Coordinate nearPt, double dist) private Coordinate
StretchedVertex.displaceFromVertex
(Coordinate nearPt, double dist) private static double
StretchedVertexFinder.distanceToSeg
(Coordinate p, Coordinate p0, Coordinate p1) GeometryVerticesMover.MoveVerticesOperation.edit
(Coordinate[] coords, Geometry geometry) void
TopologyStretcher.VertexInMaskCountCoordinateFilter.filter
(Coordinate coord) private void
StretchedVertexFinder.findNearVertex
(Coordinate[] linePts, int index) private void
StretchedVertexFinder.findNearVertex
(Coordinate[] targetPts, int index, LineString testLine) Finds a single near vertex.private static int
StretchedVertexFinder.geomPointsLen
(Coordinate[] pts) private static boolean
StretchedVertex.isFlat
(Coordinate p, Coordinate p1, Coordinate p2) private boolean
StretchedVertex.isInsideCorner
(Coordinate queryPt, Coordinate base, Coordinate p1, Coordinate p2) private static boolean
StretchedVertexFinder.isPointNearButNotOnSeg
(Coordinate p, Coordinate p0, Coordinate p1, double distTol) private Coordinate
GeometryVerticesMover.MoveVerticesOperation.movedPt
(Coordinate orig) private static Vector2D
StretchedVertex.normalizedOffset
(Coordinate p0, Coordinate p1, Coordinate p2) Returns an array of pts such that p0 - p[0] - [p1] is CW.private static Coordinate[]
StretchedVertex.orientCorner
(Coordinate p0, Coordinate p1, Coordinate p2) Returns an array of pts such that p0 - p[0] - [p1] is CW.private static int
StretchedVertex.quadrant
(Coordinate pt, Coordinate cornerBase, Coordinate[] corner) private static Coordinate
StretchedVertex.rotateToQuadrant
(Coordinate v, int quadrant) Constructors in org.locationtech.jtstest.testbuilder.topostretch with parameters of type CoordinateModifierConstructorDescriptionStretchedVertex
(Coordinate vertexPt, Coordinate[] parentLine, int parentIndex, Coordinate nearPt, Coordinate[] nearPts, int nearIndex) Creates a vertex which lies near a vertexStretchedVertex
(Coordinate vertexPt, Coordinate[] parentLine, int parentIndex, LineSegment nearSeg) Creates a vertex for a point which lies near a line segment -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.ui
Methods in org.locationtech.jtstest.testbuilder.ui that return CoordinateMethods in org.locationtech.jtstest.testbuilder.ui with parameters of type CoordinateModifier and TypeMethodDescriptionboolean
Viewport.containsInModel
(Coordinate p) GeometryLocationsWriter.OLDwriteLocation
(Geometry geom, Coordinate p, double tolerance) Viewport.toView
(Coordinate modelCoordinate) void
Viewport.transform
(Coordinate modelCoordinate, Point2D point) GeometryLocationsWriter.writeComponentLocation
(Geometry geom, Coordinate p, double tolerance) GeometryLocationsWriter.writeFacetLocation
(Geometry geom, Coordinate p, double tolerance) static String
GeometryLocationsWriter.writeLocation
(LayerList layers, Coordinate pt, double tolerance) GeometryLocationsWriter.writeLocation
(Layer lyr, Coordinate p, double tolerance) GeometryLocationsWriter.writeLocationString
(LayerList layers, Coordinate pt, double tolerance) GeometryLocationsWriter.writeSingleLocation
(Layer lyr, Coordinate p, double tolerance) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.ui.render
Fields in org.locationtech.jtstest.testbuilder.ui.render declared as Coordinate -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.ui.style
Methods in org.locationtech.jtstest.testbuilder.ui.style with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
LineStringEndpointStyle.paint
(Coordinate terminal, Coordinate next, Viewport viewport, Graphics2D graphics) protected void
SegmentStyle.paint
(int index, Coordinate p0, Coordinate p1, int lineType, Viewport viewport, Graphics2D g) -
Uses of Coordinate in org.locationtech.jtstest.testbuilder.ui.tools
Fields in org.locationtech.jtstest.testbuilder.ui.tools declared as CoordinateModifier and TypeFieldDescriptionprivate Coordinate[]
EditVertexTool.adjVertices
(package private) Coordinate
EditVertexTool.currentVertexLoc
private Coordinate
EditVertexTool.selectedVertexLocation
protected Coordinate
LineBandTool.tentativeCoordinate
Methods in org.locationtech.jtstest.testbuilder.ui.tools that return CoordinateModifier and TypeMethodDescriptionLineBandTool.lastCoordinate()
protected Coordinate[]
(package private) Coordinate
BasicTool.toModelCoordinate
(Point viewPt) protected Coordinate
BasicTool.toModelSnapped
(Point2D p) protected Coordinate
BasicTool.toModelSnappedIfCloseToViewGrid
(Point2D p) protected Coordinate
BasicTool.toModelSnappedToViewGrid
(Point2D p) Methods in org.locationtech.jtstest.testbuilder.ui.tools with parameters of type CoordinateModifier and TypeMethodDescriptionprotected void
LineBandTool.add
(Coordinate c) (package private) Point2D
BasicTool.toView
(Coordinate modePt) -
Uses of Coordinate in org.locationtech.jtstest.util.io
Methods in org.locationtech.jtstest.util.io with parameters of type CoordinateModifier and TypeMethodDescriptionprivate void
SVGWriter.appendCoordinate
(Coordinate coordinate, Writer writer) Converts aCoordinate
to<Point>
format, then appends it to the writer.private void
SVGWriter.appendPoint
(Coordinate coordinate, int level, Writer writer, PrecisionModel precisionModel) Converts aCoordinate
to <Point Text> format, then appends it to the writer.private void
SVGWriter.appendPointTaggedText
(Coordinate coordinate, int level, Writer writer, PrecisionModel precisionModel) Converts aCoordinate
to <Point Tagged Text> format, then appends it to the writer.