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.
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.
Provides classes for various kinds of spatial indexes.
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.
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.
Contains classes that perform vector overlay
to compute boolean set-theoretic spatial functions.
Contains classes to implement the computation of the spatial relationships of
Geometry
s.Classes for testing the validity and simplicity of geometries,
as defined in the OGC Simple Features specification.
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 for triangulating polygons.
Classes to implement a topological subdivision of quadeges, to support creating triangulations
and Voronoi diagrams.
Classes for representing a planar triangulation as a set of linked triangles.
Contains support classes for the Java Topology Suite.
-
Uses of Coordinate in org.locationtech.jts.algorithm
Methods in org.locationtech.jts.algorithm that return CoordinateModifier and TypeMethodDescriptionMinimumBoundingCircle.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.static Coordinate
InteriorPoint.getInteriorPoint
(Geometry geom) Computes a location of an interior point in aGeometry
.InteriorPointArea.getInteriorPoint()
Gets the computed interior point.static Coordinate
InteriorPointArea.getInteriorPoint
(Geometry geom) Computes an interior point for the polygonal components of a Geometry.InteriorPointLine.getInteriorPoint()
static Coordinate
InteriorPointLine.getInteriorPoint
(Geometry geom) Computes an interior point for the linear components of a Geometry.InteriorPointPoint.getInteriorPoint()
static Coordinate
InteriorPointPoint.getInteriorPoint
(Geometry geom) Computes an interior point for the puntal components of a Geometry.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) Deprecated.static Coordinate
Intersection.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes the intersection point of two lines.static Coordinate
Intersection.lineSegment
(Coordinate line1, Coordinate line2, Coordinate seg1, Coordinate seg2) Computes the intersection point of a line and a line segment (if any).static Coordinate
Angle.project
(Coordinate p, double angle, double dist) Projects a point by a given angle and distance.Methods in org.locationtech.jts.algorithm with parameters of type CoordinateModifier and TypeMethodDescriptionstatic double
Angle.angle
(Coordinate p) Returns the angle of 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.static double
Angle.bisector
(Coordinate tip1, Coordinate tail, Coordinate tip2) Computes the angle of the unoriented bisector of the smallest angle between two vectors.static int
PolygonNodeTopology.compareAngle
(Coordinate origin, Coordinate p, Coordinate q) Compares the angles of two vectors relative to the positive X-axis at their origin.static double
LineIntersector.computeEdgeDistance
(Coordinate p, Coordinate p0, Coordinate p1) Computes the "edge distance" of an intersection point p along a segment.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) static int
CGAlgorithms.computeOrientation
(Coordinate p1, Coordinate p2, Coordinate q) Deprecated.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.static double
CGAlgorithms.distancePointLine
(Coordinate p, Coordinate[] line) Deprecated.static double
CGAlgorithms.distancePointLine
(Coordinate p, Coordinate A, Coordinate B) Deprecated.static double
CGAlgorithms.distancePointLinePerpendicular
(Coordinate p, Coordinate A, Coordinate B) Deprecated.static 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.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) static Coordinate
Intersection.intersection
(Coordinate p1, Coordinate p2, Coordinate q1, Coordinate q2) Computes the intersection point of two lines.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.static boolean
CGAlgorithms.isCCW
(Coordinate[] ring) Deprecated.UseOrientation.isCCW(Coordinate[])
instead.static boolean
Orientation.isCCW
(Coordinate[] ring) Tests if a ring defined by an array ofCoordinate
s is oriented counter-clockwise.static boolean
Orientation.isCCWArea
(Coordinate[] ring) Tests if a ring defined by an array ofCoordinate
s is oriented counter-clockwise, using the signed area of the ring.static boolean
PolygonNodeTopology.isCrossing
(Coordinate nodePt, Coordinate a0, Coordinate a1, Coordinate b0, Coordinate b1) Check if four segments at a node cross.static boolean
PointLocation.isInRing
(Coordinate p, Coordinate[] ring) Tests whether a point lies inside or on a ring.static boolean
PolygonNodeTopology.isInteriorSegment
(Coordinate nodePt, Coordinate a0, Coordinate a1, Coordinate b) Tests whether an segment node-b lies in the interior or exterior of a corner of a ring formed by the two segments a0-node-a1.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.UsePointLocation.isOnLine(Coordinate, Coordinate[])
instead.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
PointLocation.isOnSegment
(Coordinate p, Coordinate p0, Coordinate p1) Tests whether a point lies on a line segment.static boolean
CGAlgorithms.isPointInRing
(Coordinate p, Coordinate[] ring) Deprecated.UsePointLocation.isInRing(Coordinate, Coordinate[])
instead.static Coordinate
Intersection.lineSegment
(Coordinate line1, Coordinate line2, Coordinate seg1, Coordinate seg2) Computes the intersection point of a line and a line segment (if any).int
PointLocator.locate
(Coordinate p, Geometry geom) Computes the topological relationship (Location
) of a single point to a Geometry.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.static int
CGAlgorithms.locatePointInRing
(Coordinate p, Coordinate[] ring) Deprecated.UsePointLocation.locateInRing(Coordinate, Coordinate[])
instead.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.static double
LineIntersector.nonRobustComputeEdgeDistance
(Coordinate p, Coordinate p1, Coordinate p2) 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.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
.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.pointToLinePerpendicularSigned
(Coordinate p, Coordinate A, Coordinate B) static 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.static Coordinate
Angle.project
(Coordinate p, double angle, double dist) Projects a point by a given angle and distance.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!static double
CGAlgorithms.signedArea
(Coordinate[] ring) Deprecated.UseArea.ofRing(Coordinate[])
orArea.ofRingSigned(Coordinate[])
instead.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) -
Uses of Coordinate in org.locationtech.jts.algorithm.distance
Methods in org.locationtech.jts.algorithm.distance that return CoordinateModifier and TypeMethodDescriptionPointPairDistance.getCoordinate
(int i) Gets one of the paired pointsDiscreteFrechetDistance.getCoordinates()
Gets the pair ofCoordinate
s at which the distance is obtained.DiscreteHausdorffDistance.getCoordinates()
PointPairDistance.getCoordinates()
Gets the paired pointsMethods 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) Initializes the points, computing the distance between them.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 TypeMethodDescriptionstatic boolean
SimplePointInAreaLocator.containsPointInPolygon
(Coordinate p, Polygon poly) Determines whether a point lies in aPolygon
.static boolean
SimplePointInAreaLocator.isContained
(Coordinate p, Geometry geom) Determines whether a point is contained in aGeometry
, or lies on its boundary.int
IndexedPointInAreaLocator.locate
(Coordinate p) int
PointOnGeometryLocator.locate
(Coordinate p) int
SimplePointInAreaLocator.locate
(Coordinate p) static int
SimplePointInAreaLocator.locate
(Coordinate p, Geometry geom) static int
SimplePointInAreaLocator.locatePointInPolygon
(Coordinate p, Polygon poly) -
Uses of Coordinate in org.locationtech.jts.awt
Methods in org.locationtech.jts.awt with parameters of type CoordinateModifier and TypeMethodDescriptionvoid
IdentityPointTransformation.transform
(Coordinate model, Point2D view) void
PointTransformation.transform
(Coordinate src, Point2D dest) Transforms aCoordinate
into a Java2DPoint
.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.edgegraph
Methods 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.static HalfEdge
HalfEdge.create
(Coordinate p0, Coordinate p1) Creates a HalfEdge pair representing an edge between two vertices located at coordinates p0 and p1.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.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 a half-edge originating from a given coordinate.MarkHalfEdge
(Coordinate orig) Creates a new marked edge. -
Uses of Coordinate in org.locationtech.jts.geom
Subclasses of Coordinate in org.locationtech.jts.geomModifier and TypeClassDescriptionclass
Coordinate subclass supporting XY ordinates.class
Coordinate subclass supporting XYM ordinates.class
Coordinate subclass supporting XYZM ordinates.Fields in org.locationtech.jts.geom declared as CoordinateModifier and TypeFieldDescriptionLineSegment.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 triangleMethods 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.static Coordinate
Triangle.circumcentreDD
(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()
Creates a copy of this Coordinate.static Coordinate[]
CoordinateArrays.copyDeep
(Coordinate[] coordinates) Creates a deep copy of the argumentCoordinate
array.Coordinate.create()
Create a new Coordinate of the same type as this Coordinate, but with no values.static Coordinate
Coordinates.create
(int dimension) Factory method providing access to common Coordinate implementations.static Coordinate
Coordinates.create
(int dimension, int measures) Factory method providing access to common Coordinate implementations.CoordinateXY.create()
Create a new Coordinate of the same type as this Coordinate, but with no values.CoordinateXYM.create()
Create a new Coordinate of the same type as this Coordinate, but with no values.CoordinateXYZM.create()
Create a new Coordinate of the same type as this Coordinate, but with no values.default Coordinate
CoordinateSequence.createCoordinate()
Creates a coordinate for use in this sequence.static Coordinate[]
CoordinateArrays.enforceConsistency
(Coordinate[] array, int dimension, int measures) Utility method ensuring array contents are of the specified dimension and measures.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.abstract Coordinate
Geometry.getCoordinate()
Returns a vertex of this geometry (usually, but not necessarily, the first one), ornull
if the geometry is empty.GeometryCollection.getCoordinate()
LineSegment.getCoordinate
(int i) LineString.getCoordinate()
Point.getCoordinate()
Polygon.getCoordinate()
TopologyException.getCoordinate()
CoordinateSequence.getCoordinateCopy
(int i) Returns a copy of the i'th coordinate in this sequence.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.static Coordinate
CoordinateSequences.minCoordinate
(CoordinateSequence seq) 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 pointsLineSegment.reflect
(Coordinate p) Computes the reflection of a point in the line defined by this line segment.static Coordinate[]
CoordinateArrays.removeNull
(Coordinate[] coord) Collapses a coordinate array to remove all null elements.static Coordinate[]
CoordinateArrays.removeRepeatedOrInvalidPoints
(Coordinate[] coord) If the coordinate array argument has repeated or invalid points, constructs a new array containing no repeated points.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.CoordinateList.toCoordinateArray
(boolean isForward) Creates an array containing the coordinates in this list, oriented in the given direction (forward or reverse).CoordinateSequence.toCoordinateArray()
Returns (possibly copies of) the Coordinates in this collection.PrecisionModel.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.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.static Coordinate
Triangle.circumcentreDD
(Coordinate a, Coordinate b, Coordinate c) Computes the circumcentre of a triangle.static double
Triangle.circumradius
(Coordinate a, Coordinate b, Coordinate c) Computes the radius of the circumcircle of a triangle.LineSegment.closestPoint
(Coordinate p) Computes the closest point on this line segment to another point.int
Coordinate.DimensionalComparator.compare
(Coordinate c1, Coordinate c2) Compares twoCoordinate
s along to the number of dimensions specified.static int
CoordinateArrays.compare
(Coordinate[] pts1, Coordinate[] pts2) Compares twoCoordinate
arrays in the forward direction of their coordinates, using lexicographic ordering.int
Coordinate.compareTo
(Coordinate o) Compares thisCoordinate
with the specifiedCoordinate
for order.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.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.static Point
GeometryFactory.createPointFromInternalCoord
(Coordinate coord, Geometry exemplar) GeometryFactory.createPolygon
(Coordinate[] shell) Constructs aPolygon
with the given exterior boundary.static int
CoordinateArrays.dimension
(Coordinate[] pts) Determine dimension based on subclass ofCoordinate
.static int
Coordinates.dimension
(Coordinate coordinate) Determine dimension based on subclass ofCoordinate
.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.double
LineSegment.distancePerpendicularOriented
(Coordinate p) Computes the oriented perpendicular distance between the (infinite) line defined by this line segment and a point.static void
CoordinateArrays.enforceConsistency
(Coordinate[] array) Utility method ensuring array contents are of consistent dimension and measures.static Coordinate[]
CoordinateArrays.enforceConsistency
(Coordinate[] array, int dimension, int measures) Utility method ensuring array contents are of the specified dimension and measures.static Envelope
CoordinateArrays.envelope
(Coordinate[] coordinates) Computes the envelope of the coordinates.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, within a specified tolerance value.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 the providedcoord
.void
CoordinateSequence.getCoordinate
(int index, Coordinate coord) Copies the i'th coordinate in the sequence to the suppliedCoordinate
.static boolean
CoordinateArrays.hasRepeatedOrInvalidPoints
(Coordinate[] coord) Tests whether an array has any repeated or invalid coordinates.static boolean
CoordinateArrays.hasRepeatedPoints
(Coordinate[] coord) Tests whetherequals(Object)
returns true for any two consecutive Coordinates in the given array.static boolean
Coordinates.hasZ
(Coordinate coordinate) Check if coordinate can store Z valye, based on subclass ofCoordinate
.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
.static int
CoordinateSequences.indexOf
(Coordinate coordinate, CoordinateSequence seq) Returns the index ofcoordinate
in aCoordinateSequence
The first position is 0; the second, 1; etc.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) Tests if the pointp
intersects (lies inside) the region of thisEnvelope
.boolean
Envelope.intersects
(Coordinate a, Coordinate b) Tests 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.intersects
(Coordinate a, Coordinate b, Coordinate c, Coordinate p) Tests whether a triangle intersects a point.static boolean
Triangle.isAcute
(Coordinate a, Coordinate b, Coordinate c) Tests whether a triangle is acute.static boolean
Triangle.isCCW
(Coordinate a, Coordinate b, Coordinate c) Tests whether a triangle is oriented counter-clockwise.boolean
LineString.isCoordinate
(Coordinate pt) Returns true if the given point is a vertex of thisLineString
.static boolean
CoordinateArrays.isRing
(Coordinate[] pts) Tests whether an array ofCoordinate
s forms a ring, by checking length and closure.static double
Triangle.length
(Coordinate a, Coordinate b, Coordinate c) Compute the length of the perimeter of a trianglestatic 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 int
CoordinateArrays.measures
(Coordinate[] pts) Determine number of measures based on subclass ofCoordinate
.static int
Coordinates.measures
(Coordinate coordinate) Determine number of measures based on subclass ofCoordinate
.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.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 int
Quadrant.quadrant
(Coordinate p0, Coordinate p1) Returns the quadrant of a directed line segment from p0 to p1.LineSegment.reflect
(Coordinate p) Computes the reflection of a point in the line defined by this line segment.static Coordinate[]
CoordinateArrays.removeNull
(Coordinate[] coord) Collapses a coordinate array to remove all null elements.static Coordinate[]
CoordinateArrays.removeRepeatedOrInvalidPoints
(Coordinate[] coord) If the coordinate array argument has repeated or invalid points, constructs a new array containing no repeated points.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, int indexOfFirstCoordinate) Shifts the positions of the coordinates until the coordinate atfirstCoordinate
is first.static void
CoordinateArrays.scroll
(Coordinate[] coordinates, int indexOfFirstCoordinate, boolean ensureRing) Shifts the positions of the coordinates until the coordinate atindexOfFirstCoordinate
is first.static void
CoordinateArrays.scroll
(Coordinate[] coordinates, Coordinate firstCoordinate) Shifts the positions of the coordinates untilfirstCoordinate
is first.static void
CoordinateSequences.scroll
(CoordinateSequence seq, 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
CoordinateXY.setCoordinate
(Coordinate other) void
CoordinateXYM.setCoordinate
(Coordinate other) void
CoordinateXYZM.setCoordinate
(Coordinate other) 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 insteadMethod parameters in org.locationtech.jts.geom with type arguments of type CoordinateModifier and TypeMethodDescriptionboolean
CoordinateList.addAll
(Collection<? extends Coordinate> coll, boolean allowRepeated) Add an array of coordinatesConstructors 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.CoordinateXY
(Coordinate coord) Constructs a CoordinateXY instance with the x and y ordinates of the given Coordinate.CoordinateXYM
(Coordinate coord) Constructs a CoordinateXYM instance with the x and y ordinates of the given Coordinate.CoordinateXYZM
(Coordinate coord) Constructs a CoordinateXYZM instance with the ordinates of the given Coordinate.Creates anEnvelope
for a region defined by a single Coordinate.Envelope
(Coordinate p1, Coordinate p2) Creates anEnvelope
for a region defined by two Coordinates.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
Methods in org.locationtech.jts.geom.impl that return CoordinateModifier and TypeMethodDescriptionCoordinateArraySequence.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) CoordinateArraySequence.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).CoordinateArraySequence
(Coordinate[] coordinates, int dimension, int measures) 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 arrayDouble
(Coordinate[] coordinates, int dimension, int measures) Builds a new packed coordinate sequence out of a coordinate arrayFloat
(Coordinate[] coordinates, int dimension) Builds a new packed coordinate sequence out of a coordinate arrayFloat
(Coordinate[] coordinates, int dimension, int measures) Constructs a packed coordinate sequence out of a coordinate array -
Uses of Coordinate in org.locationtech.jts.geom.util
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 TypeMethodDescriptionstatic Geometry
SineStarFactory.create
(Coordinate origin, double size, int nPts, int nArms, double armLengthRatio) Creates a sine star with the given parameters.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) Deprecated.use AffineTransformationFactoryAffineTransformationBuilder
(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 CoordinateMethods 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.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) Find coordinate.PlanarGraph.find
(Coordinate coord) Find coordinate.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 p1boolean
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.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) EdgeIntersection.Node
(Coordinate coord, EdgeEndStar edges) -
Uses of Coordinate in org.locationtech.jts.geomgraph.index
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 TypeMethodDescriptionint[]
MonotoneChainIndexer.getChainStartIndices
(Coordinate[] pts) int[]
MonotoneChainIndexer.OLDgetChainStartIndices
(Coordinate[] pts) -
Uses of Coordinate in org.locationtech.jts.index
Constructors in org.locationtech.jts.index with parameters of type CoordinateModifierConstructorDescriptionCreates a new tree over the given sequence of coordinates. -
Uses of Coordinate in org.locationtech.jts.index.chain
Methods 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 TypeMethodDescriptionstatic List
MonotoneChainBuilder.getChains
(Coordinate[] pts) Computes a list of theMonotoneChain
s for a list of coordinates.static List
MonotoneChainBuilder.getChains
(Coordinate[] pts, Object context) Computes a list of theMonotoneChain
s for a list of coordinates, attaching a context data object to each.Constructors in org.locationtech.jts.index.chain with parameters of type CoordinateModifierConstructorDescriptionMonotoneChain
(Coordinate[] pts, int start, int end, Object context) Creates a new MonotoneChain based on the given array of points. -
Uses of Coordinate in org.locationtech.jts.index.kdtree
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 TypeMethodDescriptionKdTree.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.KdTree.query
(Coordinate queryPt) Searches for a given point in the index and returns its node if found.Constructors in org.locationtech.jts.index.kdtree with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.index.quadtree
Methods in org.locationtech.jts.index.quadtree that return Coordinate -
Uses of Coordinate in org.locationtech.jts.io
Methods in org.locationtech.jts.io with parameters of type CoordinateModifier and TypeMethodDescriptionstatic String
WKTWriter.format
(Coordinate p) 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
. -
Uses of Coordinate in org.locationtech.jts.linearref
Methods 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).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.LocationIndexedLine.indexOf
(Coordinate pt) Computes the index for a given point on the line.double
LengthIndexedLine.indexOfAfter
(Coordinate pt, double minIndex) Finds the index for a point on the line which is greater than the given index.LocationIndexedLine.indexOfAfter
(Coordinate pt, LinearLocation minIndex) Finds the index for a point on the line which is greater than the given index.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. -
Uses of Coordinate in org.locationtech.jts.math
Methods in org.locationtech.jts.math that return CoordinateModifier and TypeMethodDescriptionstatic Coordinate
Vector3D.normalize
(Coordinate v) Computes a vector having identical direction but normalized to have length 1.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 a 3DCoordinate
.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) Computes the length of a vector.static Coordinate
Vector3D.normalize
(Coordinate v) Computes a vector having identical direction but normalized to have length 1.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) Creates a new 3D vector from aCoordinate
.Vector3D
(Coordinate from, Coordinate to) Creates a new vector with the direction and magnitude of the difference between the to and fromCoordinate
s. -
Uses of Coordinate in org.locationtech.jts.noding
Fields in org.locationtech.jts.noding declared as CoordinateMethods 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) Gets the segment string coordinate at a given index.BasicSegmentString.getCoordinates()
NodedSegmentString.getCoordinates()
SegmentString.getCoordinates()
Gets the coordinates in this segment string.NodingIntersectionFinder.getIntersection()
Gets the computed location of the intersection.SegmentIntersectionDetector.getIntersection()
Gets the computed location of the intersection.NodingIntersectionFinder.getIntersectionSegments()
Gets the endpoints of the intersecting segments.SegmentIntersectionDetector.getIntersectionSegments()
Gets the endpoints of the intersecting segments.NodedSegmentString.getNodedCoordinates()
Gets a list of coordinates with all nodes included.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.default Coordinate
SegmentString.nextInRing
(int index) Gets the next vertex in a ring from a vertex index.default Coordinate
SegmentString.prevInRing
(int index) Gets the previous vertex in a ring from a vertex index.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.static int
SegmentPointComparator.compare
(int octant, Coordinate p0, Coordinate p1) Compares twoCoordinate
s for their relative position along a segment lying in the specifiedOctant
.static int
Octant.octant
(Coordinate p0, Coordinate p1) Returns the octant of a directed line segment from p0 to p1.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 instance from a list of vertices and optional data object.Creates a newOrientedCoordinateArray
for the givenCoordinate
array.SegmentNode
(NodedSegmentString segString, Coordinate coord, int segmentIndex, int segmentOctant) -
Uses of Coordinate in org.locationtech.jts.noding.snap
Methods in org.locationtech.jts.noding.snap that return CoordinateModifier and TypeMethodDescriptionSnappingPointIndex.snap
(Coordinate p) Snaps a coordinate to an existing snap point, if it is within the snap tolerance distance.Methods in org.locationtech.jts.noding.snap with parameters of type CoordinateModifier and TypeMethodDescriptionSnappingPointIndex.snap
(Coordinate p) Snaps a coordinate to an existing snap point, if it is within the snap tolerance distance. -
Uses of Coordinate in org.locationtech.jts.noding.snapround
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 that return types with arguments of type CoordinateModifier and TypeMethodDescriptionSnapRoundingIntersectionAdder.getIntersections()
Gets the created intersection nodes, so they can be processed as hot pixels.Methods in org.locationtech.jts.noding.snapround with parameters of type CoordinateModifier and TypeMethodDescriptionboolean
HotPixel.intersects
(Coordinate p) Tests whether a coordinate lies in (intersects) this hot pixel.boolean
HotPixel.intersects
(Coordinate p0, Coordinate p1) Tests whether the line segment (p0-p1) intersects this hot pixel.Constructors in org.locationtech.jts.noding.snapround with parameters of type CoordinateModifierConstructorDescriptionHotPixel
(Coordinate pt, double scaleFactor) Creates a new hot pixel centered on a rounded point, using a given scale factor. -
Uses of Coordinate in org.locationtech.jts.operation
Methods in org.locationtech.jts.operation that return CoordinateModifier and TypeMethodDescriptionIsSimpleOp.getNonSimpleLocation()
Deprecated.Gets a coordinate for the location where the geometry fails to be simple. -
Uses of Coordinate in org.locationtech.jts.operation.buffer
Methods in org.locationtech.jts.operation.buffer that return CoordinateModifier and TypeMethodDescriptionOffsetCurveBuilder.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 valid rings.static Coordinate[]
OffsetCurve.rawOffset
(LineString line, double distance) Gets the raw offset curve for a line at a given distance, with default buffer parameters.static Coordinate[]
OffsetCurve.rawOffset
(LineString line, double distance, BufferParameters bufParams) Gets the raw offset curve for a line at a given distance.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 TypeMethodDescriptionOffsetCurveBuilder.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 valid rings.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
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) void
PointPairDistance.setMaximum
(Coordinate p0, Coordinate p1) void
PointPairDistance.setMinimum
(Coordinate p0, Coordinate p1) -
Uses of Coordinate in org.locationtech.jts.operation.distance
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.IndexedFacetDistance.nearestPoints
(Geometry g) Compute the nearest locations on the target geometry and the given geometry.static Coordinate[]
IndexedFacetDistance.nearestPoints
(Geometry g1, Geometry g2) Computes the nearest points of the facets of two geometries.Constructors in org.locationtech.jts.operation.distance with parameters of type 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 TypeMethodDescriptionAxisPlaneCoordinateSequence.getCoordinate
(int i) AxisPlaneCoordinateSequence.getCoordinateCopy
(int i) 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.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) -
Uses of Coordinate in org.locationtech.jts.operation.linemerge
Constructors 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 TypeMethodDescriptionOverlayNodeFactory.createNode
(Coordinate coord) 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
Methods in org.locationtech.jts.operation.overlay.snap that return CoordinateModifier and TypeMethodDescriptionLineStringSnapper.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 TypeMethodDescriptionLineStringSnapper.snapTo
(Coordinate[] snapPts) Snaps the vertices and segments of the source LineString to the given set of snap vertices.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. -
Uses of Coordinate in org.locationtech.jts.operation.overlay.validate
Methods in org.locationtech.jts.operation.overlay.validate that return CoordinateMethods in org.locationtech.jts.operation.overlay.validate with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.operation.overlayng
Methods in org.locationtech.jts.operation.overlayng that return CoordinateModifier and TypeMethodDescriptionRingClipper.clip
(Coordinate[] pts) Clips a list of points to the clipping rectangle box.Methods in org.locationtech.jts.operation.overlayng with parameters of type CoordinateModifier and TypeMethodDescriptionRingClipper.clip
(Coordinate[] pts) Clips a list of points to the clipping rectangle box.List
<Coordinate[]> LineLimiter.limit
(Coordinate[] pts) Limits a list of segments. -
Uses of Coordinate in org.locationtech.jts.operation.relate
Methods 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
Methods in org.locationtech.jts.operation.valid that return CoordinateModifier and TypeMethodDescriptionRepeatedPointTester.getCoordinate()
TopologyValidationError.getCoordinate()
Returns the location of this error (on theGeometry
containing the error).IsSimpleOp.getNonSimpleLocation()
Gets the coordinate for an location where the geometry fails to be simple.static Coordinate
IsSimpleOp.getNonSimpleLocation
(Geometry geom) Gets a non-simple location in a geometry, if any.Methods in org.locationtech.jts.operation.valid that return types with arguments of type CoordinateModifier and TypeMethodDescriptionIsSimpleOp.getNonSimpleLocations()
Gets all non-simple intersection locations.Methods in org.locationtech.jts.operation.valid with parameters of type CoordinateModifier and TypeMethodDescriptionboolean
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
Methods 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
Methods in org.locationtech.jts.precision that return CoordinateModifier and TypeMethodDescriptionPrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) CommonBitsRemover.getCommonCoordinate()
The common bits of the Coordinates in the supplied Geometries.Methods in org.locationtech.jts.precision with parameters of type CoordinateModifier and TypeMethodDescriptionPrecisionReducerCoordinateOperation.edit
(Coordinate[] coordinates, Geometry geom) -
Uses of Coordinate in org.locationtech.jts.shape
Methods in org.locationtech.jts.shape that return Coordinate -
Uses of Coordinate in org.locationtech.jts.shape.fractal
Methods in org.locationtech.jts.shape.fractal that return CoordinateModifier and TypeMethodDescriptionstatic Coordinate
HilbertCode.decode
(int level, int index) Computes the point on a Hilbert curve of given level for a given code index.static Coordinate
MortonCode.decode
(int index) Computes the point on the Morton curve for a given index.Methods in org.locationtech.jts.shape.fractal with parameters of type CoordinateModifier and TypeMethodDescriptionvoid
KochSnowflakeBuilder.addSide
(int level, Coordinate p0, Coordinate p1) -
Uses of Coordinate in org.locationtech.jts.simplify
Methods in org.locationtech.jts.simplify that return CoordinateModifier and TypeMethodDescriptionLinkedLine.getCoordinate
(int index) LinkedLine.getCoordinates()
LinkedLine.nextCoordinate
(int index) LinkedLine.prevCoordinate
(int index) Constructors in org.locationtech.jts.simplify with parameters of type Coordinate -
Uses of Coordinate in org.locationtech.jts.triangulate
Methods in org.locationtech.jts.triangulate that return CoordinateModifier and TypeMethodDescriptionConstraintSplitPointFinder.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 segmentSplitSegment.getSplitPoint()
Segment.getStart()
Gets the start coordinate of the segmentSegment.intersection
(Segment s) Computes the intersection point between this segment and another one.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 TypeMethodDescriptionConstraintVertexFactory.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.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.polygon
Methods in org.locationtech.jts.triangulate.polygon that return CoordinateModifier and TypeMethodDescriptionPolygonHoleJoiner.compute()
Computes the joined ring.static Coordinate[]
Joins the shell and holes of a polygon and returns the result as sequence of Coordinates. -
Uses of Coordinate in org.locationtech.jts.triangulate.quadedge
Methods 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 TypeMethodDescriptionboolean
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.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.triangulate.tri
Methods in org.locationtech.jts.triangulate.tri that return CoordinateModifier and TypeMethodDescriptionTri.getCoordinate
(int index) Gets the coordinate for a vertex.Tri.midpoint
(int edgeIndex) Computes a coordinate for the midpoint of a triangle edge.Methods in org.locationtech.jts.triangulate.tri with parameters of type CoordinateModifier and TypeMethodDescriptionstatic Tri
Tri.create
(Coordinate[] pts) Creates a triangle from an array with three vertex coordinates.static Tri
Tri.create
(Coordinate p0, Coordinate p1, Coordinate p2) Creates a triangle with the given vertices.int
Tri.getIndex
(Coordinate p) Gets the index of the triangle vertex which has a given coordinate (if any).void
Tri.setAdjacent
(Coordinate pt, Tri tri) Sets the triangle adjacent to the edge originating at a given vertex.Tri.split
(Coordinate p) Spits a triangle by a point located inside the triangle.Constructors in org.locationtech.jts.triangulate.tri with parameters of type CoordinateModifierConstructorDescriptionTri
(Coordinate p0, Coordinate p1, Coordinate p2) Creates a triangle with the given vertices. -
Uses of Coordinate in org.locationtech.jts.util
Methods in org.locationtech.jts.util that return CoordinateModifier and TypeMethodDescriptionstatic Coordinate[]
UniqueCoordinateArrayFilter.filterCoordinates
(Coordinate[] coords) Convenience method which allows running the filter over an array ofCoordinate
s.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) 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.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.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) -
Uses of Coordinate in org.locationtech.jtslab.geom.util
Methods in org.locationtech.jtslab.geom.util that return CoordinateModifier and TypeMethodDescriptionabstract Coordinate[]
GeometryEditorEx.CoordinateOperation.edit
(Coordinate[] coordinates, Geometry geometry) Edits the array ofCoordinate
s from aGeometry
.Methods in org.locationtech.jtslab.geom.util with parameters of type CoordinateModifier and TypeMethodDescriptionabstract Coordinate[]
GeometryEditorEx.CoordinateOperation.edit
(Coordinate[] coordinates, Geometry geometry) Edits the array ofCoordinate
s from aGeometry
.
Intersection.intersection(Coordinate, Coordinate, Coordinate, Coordinate)