Uses of Class
com.vividsolutions.jts.geom.Geometry

Packages that use Geometry
com.vividsolutions.jts.algorithm Contains classes and interfaces implementing fundamental computational geometry algorithms. 
com.vividsolutions.jts.algorithm.distance Classes to compute distance metrics between geonetries. 
com.vividsolutions.jts.algorithm.locate Classes to determine the topological location of points in geometries. 
com.vividsolutions.jts.algorithm.match Classes to compute matching metrics between geometries. 
com.vividsolutions.jts.awt Classes to perform conversions from Java2D shape objects. 
com.vividsolutions.jts.densify Classes to perform densification on geometries. 
com.vividsolutions.jts.geom Contains the Geometry interface hierarchy and supporting classes. 
com.vividsolutions.jts.geom.prep Classes to perform optimized geometric operations on suitably prepared geometries. 
com.vividsolutions.jts.geom.util Provides classes that parse and modify Geometry objects. 
com.vividsolutions.jts.geomgraph Contains classes that implement topology graphs. 
com.vividsolutions.jts.io Contains the interfaces for converting JTS objects to and from other formats. 
com.vividsolutions.jts.io.gml2 Classes to read and write the GML2 geometry format. 
com.vividsolutions.jts.linearref Contains classes and interfaces implementing linear referencing on linear geometries 
com.vividsolutions.jts.noding Classes to compute nodings for arrangements of line segments and line segment sequences. 
com.vividsolutions.jts.operation Provides classes for implementing operations on geometries 
com.vividsolutions.jts.operation.buffer Provides classes for computing buffers of geometries 
com.vividsolutions.jts.operation.buffer.validate Classes to perform validation of the results of buffer operations. 
com.vividsolutions.jts.operation.distance Provides classes for computing the distance between geometries 
com.vividsolutions.jts.operation.distance3d   
com.vividsolutions.jts.operation.linemerge Classes to perform line merging. 
com.vividsolutions.jts.operation.overlay Contains classes that perform a topological overlay to compute boolean spatial functions. 
com.vividsolutions.jts.operation.overlay.snap Classes to perform snapping on geometries to prepare them for overlay operations. 
com.vividsolutions.jts.operation.overlay.validate Classes to validate the results of overlay operations. 
com.vividsolutions.jts.operation.polygonize An API for polygonizing sets of lines. 
com.vividsolutions.jts.operation.predicate Classes which implement topological predicates optimized for particular kinds of geometries. 
com.vividsolutions.jts.operation.relate Contains classes to implement the computation of the spatial relationships of Geometrys. 
com.vividsolutions.jts.operation.union Classes to perform efficent unioning of collections of geometries. 
com.vividsolutions.jts.operation.valid Provides classes for testing the validity of geometries. 
com.vividsolutions.jts.precision Provides classes for analyzing and manipulating the precision of Geometries. 
com.vividsolutions.jts.shape   
com.vividsolutions.jts.shape.fractal   
com.vividsolutions.jts.shape.random   
com.vividsolutions.jts.simplify Classes which implement algorithms for simplifying or generalizing geometries. 
com.vividsolutions.jts.triangulate Classes to compute Delaunay triangulations. 
com.vividsolutions.jts.triangulate.quadedge Classes to implement a topological subdivision of quadeges, to support creating triangulations and Voronoi diagrams. 
com.vividsolutions.jts.util Contains support classes for the Java Topology Suite. 
com.vividsolutions.jtsexample.technique   
 

Uses of Geometry in com.vividsolutions.jts.algorithm
 

Methods in com.vividsolutions.jts.algorithm that return Geometry
 Geometry MinimumBoundingCircle.getCircle()
          Gets a geometry which represents the Minimum Bounding Circle.
 Geometry ConvexHull.getConvexHull()
          Returns a Geometry that represents the convex hull of the input geometry.
 Geometry MinimumDiameter.getMinimumRectangle()
          Gets the minimum rectangular Polygon which encloses the input geometry.
protected  Geometry InteriorPointArea.widestGeometry(Geometry geometry)
           
 

Methods in com.vividsolutions.jts.algorithm with parameters of type Geometry
 void CentroidPoint.add(Geometry geom)
          Adds the point(s) defined by a Geometry to the centroid total.
 void CentroidLine.add(Geometry geom)
          Adds the linear components of by a Geometry to the centroid total.
 void CentroidArea.add(Geometry geom)
          Adds the area defined by a Geometry to the centroid total.
 void InteriorPointArea.addPolygon(Geometry geometry)
          Finds a reasonable point at which to label a Geometry.
protected  LineString InteriorPointArea.horizontalBisector(Geometry geometry)
           
 boolean PointLocator.intersects(Coordinate p, Geometry geom)
          Convenience method to test a point for intersection with a Geometry
 int PointLocator.locate(Coordinate p, Geometry geom)
          Computes the topological relationship (Location) of a single point to a Geometry.
protected  Geometry InteriorPointArea.widestGeometry(Geometry geometry)
           
 

Constructors in com.vividsolutions.jts.algorithm with parameters of type Geometry
ConvexHull(Geometry geometry)
          Create a new convex hull construction for the input Geometry.
InteriorPointArea(Geometry g)
           
InteriorPointLine(Geometry g)
           
InteriorPointPoint(Geometry g)
           
MinimumBoundingCircle(Geometry geom)
          Creates a new object for computing the minimum bounding circle for the point set defined by the vertices of the given geometry.
MinimumDiameter(Geometry inputGeom)
          Compute a minimum diameter for a given Geometry.
MinimumDiameter(Geometry inputGeom, boolean isConvex)
          Compute a minimum diameter for a giver Geometry, with a hint if the Geometry is convex (e.g.
 

Uses of Geometry in com.vividsolutions.jts.algorithm.distance
 

Methods in com.vividsolutions.jts.algorithm.distance with parameters of type Geometry
static void DistanceToPoint.computeDistance(Geometry geom, Coordinate pt, PointPairDistance ptDist)
           
static double DiscreteHausdorffDistance.distance(Geometry g0, Geometry g1)
           
static double DiscreteHausdorffDistance.distance(Geometry g0, Geometry g1, double densifyFrac)
           
 

Constructors in com.vividsolutions.jts.algorithm.distance with parameters of type Geometry
DiscreteHausdorffDistance.MaxDensifiedByFractionDistanceFilter(Geometry geom, double fraction)
           
DiscreteHausdorffDistance.MaxPointDistanceFilter(Geometry geom)
           
DiscreteHausdorffDistance(Geometry g0, Geometry g1)
           
 

Uses of Geometry in com.vividsolutions.jts.algorithm.locate
 

Methods in com.vividsolutions.jts.algorithm.locate with parameters of type Geometry
static int SimplePointInAreaLocator.locate(Coordinate p, Geometry geom)
          Determines the Location of a point in an areal Geometry.
 

Constructors in com.vividsolutions.jts.algorithm.locate with parameters of type Geometry
IndexedPointInAreaLocator(Geometry g)
          Creates a new locator for a given Geometry
SimplePointInAreaLocator(Geometry geom)
           
 

Uses of Geometry in com.vividsolutions.jts.algorithm.match
 

Methods in com.vividsolutions.jts.algorithm.match with parameters of type Geometry
 double SimilarityMeasure.measure(Geometry g1, Geometry g2)
           
 double HausdorffSimilarityMeasure.measure(Geometry g1, Geometry g2)
           
 double AreaSimilarityMeasure.measure(Geometry g1, Geometry g2)
           
 

Uses of Geometry in com.vividsolutions.jts.awt
 

Methods in com.vividsolutions.jts.awt that return Geometry
 Geometry ShapeReader.read(PathIterator pathIt)
          Converts a flat path to a Geometry.
static Geometry ShapeReader.read(PathIterator pathIt, GeometryFactory geomFact)
          Converts a flat path to a Geometry.
static Geometry ShapeReader.read(Shape shp, double flatness, GeometryFactory geomFact)
          Converts a Shape to a Geometry, flattening it first.
static Geometry FontGlyphReader.read(String text, Font font, double flatness, GeometryFactory geomFact)
          Converts text rendered in the given Font to a Geometry
static Geometry FontGlyphReader.read(String text, Font font, GeometryFactory geomFact)
          Converts text rendered in the given Font to a Geometry using a standard flatness factor.
static Geometry FontGlyphReader.read(String text, String fontName, int pointSize, GeometryFactory geomFact)
          Converts text rendered in the given font and pointsize to a Geometry using a standard flatness factor.
 

Methods in com.vividsolutions.jts.awt with parameters of type Geometry
 Shape ShapeWriter.toShape(Geometry geometry)
          Creates a Shape representing a Geometry, according to the specified PointTransformation and PointShapeFactory (if relevant).
 

Uses of Geometry in com.vividsolutions.jts.densify
 

Methods in com.vividsolutions.jts.densify that return Geometry
static Geometry Densifier.densify(Geometry geom, double distanceTolerance)
          Densifies a geometry using a given distance tolerance, and respecting the input geometry's PrecisionModel.
 Geometry Densifier.getResultGeometry()
          Gets the densified geometry.
 

Methods in com.vividsolutions.jts.densify with parameters of type Geometry
static Geometry Densifier.densify(Geometry geom, double distanceTolerance)
          Densifies a geometry using a given distance tolerance, and respecting the input geometry's PrecisionModel.
 

Constructors in com.vividsolutions.jts.densify with parameters of type Geometry
Densifier(Geometry inputGeom)
          Creates a new densifier instance.
 

Uses of Geometry in com.vividsolutions.jts.geom
 

Subclasses of Geometry in com.vividsolutions.jts.geom
 class GeometryCollection
          Models a collection of Geometrys of arbitrary type and dimension.
 class LinearRing
          Models an OGC SFS LinearRing.
 class LineString
          Models an OGC-style LineString.
 class MultiLineString
          Models a collection of (@link LineString}s.
 class MultiPoint
          Models a collection of Points.
 class MultiPolygon
          Models a collection of Polygons.
 class Point
          Represents a single point.
 class Polygon
          Represents a polygon with linear edges, which may include holes.
 

Fields in com.vividsolutions.jts.geom declared as Geometry
protected  Geometry[] GeometryCollection.geometries
          Internal representation of this GeometryCollection.
 

Methods in com.vividsolutions.jts.geom that return Geometry
 Geometry Geometry.buffer(double distance)
          Computes a buffer area around this geometry having the given width.
 Geometry Geometry.buffer(double distance, int quadrantSegments)
          Computes a buffer area around this geometry having the given width and with a specified accuracy of approximation for circular arcs.
 Geometry Geometry.buffer(double distance, int quadrantSegments, int endCapStyle)
          Computes a buffer area around this geometry having the given width and with a specified accuracy of approximation for circular arcs, and using a specified end cap style.
 Geometry GeometryFactory.buildGeometry(Collection geomList)
          Build an appropriate Geometry, MultiGeometry, or GeometryCollection to contain the Geometrys in it.
 Geometry Polygon.convexHull()
           
 Geometry Geometry.convexHull()
          Computes the smallest convex Polygon that contains all the points in the Geometry.
 Geometry GeometryFactory.createGeometry(Geometry g)
          Creates a deep copy of the input Geometry.
 Geometry Geometry.difference(Geometry other)
          Computes a Geometry representing the closure of the point-set of the points contained in this Geometry that are not contained in the other Geometry.
 Geometry Polygon.getBoundary()
          Computes the boundary of this geometry
 Geometry Point.getBoundary()
          Gets the boundary of this geometry.
 Geometry MultiPolygon.getBoundary()
          Computes the boundary of this geometry
 Geometry MultiPoint.getBoundary()
          Gets the boundary of this geometry.
 Geometry MultiLineString.getBoundary()
          Gets the boundary of this geometry.
 Geometry LineString.getBoundary()
          Gets the boundary of this geometry.
 Geometry GeometryCollection.getBoundary()
           
abstract  Geometry Geometry.getBoundary()
          Returns the boundary, or an empty geometry of appropriate dimension if this Geometry is empty.
 Geometry Geometry.getEnvelope()
          Gets a Geometry representing the envelope (bounding box) of this Geometry.
 Geometry GeometryCollection.getGeometryN(int n)
           
 Geometry Geometry.getGeometryN(int n)
          Returns an element Geometry from a GeometryCollection (or this, if the geometry is not a collection).
 Geometry Geometry.intersection(Geometry other)
          Computes a Geometry representing the point-set which is common to both this Geometry and the other Geometry.
 Geometry Geometry.norm()
          Creates a new Geometry which is a normalized copy of this Geometry.
 Geometry Polygon.reverse()
           
 Geometry Point.reverse()
           
 Geometry MultiPolygon.reverse()
          Creates a MultiPolygon with every component reversed.
 Geometry MultiLineString.reverse()
          Creates a MultiLineString in the reverse order to this object.
 Geometry LineString.reverse()
          Creates a LineString whose coordinates are in the reverse order of this objects
 Geometry LinearRing.reverse()
           
 Geometry GeometryCollection.reverse()
          Creates a GeometryCollection with every component reversed.
abstract  Geometry Geometry.reverse()
          Computes a new geometry which has all component coordinate sequences in reverse order (opposite orientation) to this one.
 Geometry Geometry.symDifference(Geometry other)
          Computes a Geometry representing the closure of the point-set which is the union of the points in this Geometry which are not contained in the other Geometry, with the points in the other Geometry not contained in this Geometry.
 Geometry GeometryFactory.toGeometry(Envelope envelope)
          Creates a Geometry with the same extent as the given envelope.
 Geometry OctagonalEnvelope.toGeometry(GeometryFactory geomFactory)
           
static Geometry[] GeometryFactory.toGeometryArray(Collection geometries)
          Converts the List to an array.
 Geometry Geometry.union()
          Computes the union of all the elements of this geometry.
 Geometry Geometry.union(Geometry other)
          Computes a Geometry representing the point-set which is contained in both this Geometry and the other Geometry.
 

Methods in com.vividsolutions.jts.geom with parameters of type Geometry
protected  void Geometry.checkNotGeometryCollection(Geometry g)
          Throws an exception if g's class is GeometryCollection .
 boolean Geometry.contains(Geometry g)
          Tests whether this geometry contains the argument geometry.
 boolean Geometry.coveredBy(Geometry g)
          Tests whether this geometry is covered by the argument geometry.
 boolean Geometry.covers(Geometry g)
          Tests whether this geometry covers the argument geometry.
 Geometry GeometryFactory.createGeometry(Geometry g)
          Creates a deep copy of the input Geometry.
 GeometryCollection GeometryFactory.createGeometryCollection(Geometry[] geometries)
          Creates a GeometryCollection using the given Geometries; a null or empty array will create an empty GeometryCollection.
static Point GeometryFactory.createPointFromInternalCoord(Coordinate coord, Geometry exemplar)
           
 boolean Geometry.crosses(Geometry g)
          Tests whether this geometry crosses the argument geometry.
 Geometry Geometry.difference(Geometry other)
          Computes a Geometry representing the closure of the point-set of the points contained in this Geometry that are not contained in the other Geometry.
 boolean Geometry.disjoint(Geometry g)
          Tests whether this geometry is disjoint from the argument geometry.
 double Geometry.distance(Geometry g)
          Returns the minimum distance between this Geometry and another Geometry.
 boolean Geometry.equals(Geometry g)
          Tests whether this geometry is topologically equal to the argument geometry.
 boolean Geometry.equalsExact(Geometry other)
          Returns true if the two Geometrys are exactly equal.
 boolean Polygon.equalsExact(Geometry other, double tolerance)
           
 boolean Point.equalsExact(Geometry other, double tolerance)
           
 boolean MultiPolygon.equalsExact(Geometry other, double tolerance)
           
 boolean MultiPoint.equalsExact(Geometry other, double tolerance)
           
 boolean MultiLineString.equalsExact(Geometry other, double tolerance)
           
 boolean LineString.equalsExact(Geometry other, double tolerance)
           
 boolean GeometryCollection.equalsExact(Geometry other, double tolerance)
           
abstract  boolean Geometry.equalsExact(Geometry other, double tolerance)
          Returns true if the two Geometrys are exactly equal, up to a specified distance tolerance.
 boolean Geometry.equalsNorm(Geometry g)
          Tests whether two geometries are exactly equal in their normalized forms.
 boolean Geometry.equalsTopo(Geometry g)
          Tests whether this geometry is topologically equal to the argument geometry as defined by the SFS equals predicate.
 void OctagonalEnvelope.expandToInclude(Geometry g)
           
 void GeometryFilter.filter(Geometry geom)
          Performs an operation with or on geom.
 void GeometryComponentFilter.filter(Geometry geom)
          Performs an operation with or on geom.
protected static boolean Geometry.hasNonEmptyElements(Geometry[] geometries)
          Returns true if the array contains any non-empty Geometrys.
 Geometry Geometry.intersection(Geometry other)
          Computes a Geometry representing the point-set which is common to both this Geometry and the other Geometry.
 boolean Geometry.intersects(Geometry g)
          Tests whether this geometry intersects the argument geometry.
protected  boolean LineString.isEquivalentClass(Geometry other)
           
protected  boolean Geometry.isEquivalentClass(Geometry other)
          Returns whether the two Geometrys are equal, from the point of view of the equalsExact method.
 boolean Geometry.isWithinDistance(Geometry geom, double distance)
          Tests whether the distance from this Geometry to another is less than or equal to a specified value.
 boolean Geometry.overlaps(Geometry g)
          Tests whether this geometry overlaps the specified geometry.
 IntersectionMatrix Geometry.relate(Geometry g)
          Returns the DE-9IM IntersectionMatrix for the two Geometrys.
 boolean Geometry.relate(Geometry g, String intersectionPattern)
          Tests whether the elements in the DE-9IM IntersectionMatrix for the two Geometrys match the elements in intersectionPattern.
 Geometry Geometry.symDifference(Geometry other)
          Computes a Geometry representing the closure of the point-set which is the union of the points in this Geometry which are not contained in the other Geometry, with the points in the other Geometry not contained in this Geometry.
 boolean Geometry.touches(Geometry g)
          Tests whether this geometry touches the argument geometry.
 Geometry Geometry.union(Geometry other)
          Computes a Geometry representing the point-set which is contained in both this Geometry and the other Geometry.
 boolean Geometry.within(Geometry g)
          Tests whether this geometry is within the specified geometry.
 

Constructors in com.vividsolutions.jts.geom with parameters of type Geometry
GeometryCollection(Geometry[] geometries, GeometryFactory factory)
           
GeometryCollection(Geometry[] geometries, PrecisionModel precisionModel, int SRID)
          Deprecated. Use GeometryFactory instead
GeometryCollectionIterator(Geometry parent)
          Constructs an iterator over the given Geometry.
OctagonalEnvelope(Geometry geom)
          Creates a new null bounding octagon bounding a Geometry
 

Uses of Geometry in com.vividsolutions.jts.geom.prep
 

Methods in com.vividsolutions.jts.geom.prep that return Geometry
 Geometry PreparedGeometry.getGeometry()
          Gets the original Geometry which has been prepared.
 

Methods in com.vividsolutions.jts.geom.prep with parameters of type Geometry
 boolean PreparedPolygon.contains(Geometry g)
           
 boolean PreparedGeometry.contains(Geometry geom)
          Tests whether the base Geometry contains a given geometry.
 boolean PreparedPolygon.containsProperly(Geometry g)
           
 boolean PreparedGeometry.containsProperly(Geometry geom)
          Tests whether the base Geometry properly contains a given geometry.
 boolean PreparedGeometry.coveredBy(Geometry geom)
          Tests whether the base Geometry is covered by a given geometry.
 boolean PreparedPolygon.covers(Geometry g)
           
 boolean PreparedGeometry.covers(Geometry geom)
          Tests whether the base Geometry covers a given geometry.
 PreparedGeometry PreparedGeometryFactory.create(Geometry geom)
          Creates a new PreparedGeometry appropriate for the argument Geometry.
 boolean PreparedGeometry.crosses(Geometry geom)
          Tests whether the base Geometry crosses a given geometry.
 boolean PreparedGeometry.disjoint(Geometry geom)
          Tests whether the base Geometry is disjoint from a given geometry.
 boolean PreparedPolygon.intersects(Geometry g)
           
 boolean PreparedPoint.intersects(Geometry g)
          Tests whether this point intersects a Geometry.
 boolean PreparedLineString.intersects(Geometry g)
           
 boolean PreparedGeometry.intersects(Geometry geom)
          Tests whether the base Geometry intersects a given geometry.
 boolean PreparedGeometry.overlaps(Geometry geom)
          Tests whether the base Geometry overlaps a given geometry.
static PreparedGeometry PreparedGeometryFactory.prepare(Geometry geom)
          Creates a new PreparedGeometry appropriate for the argument Geometry.
 boolean PreparedGeometry.touches(Geometry geom)
          Tests whether the base Geometry touches a given geometry.
 boolean PreparedGeometry.within(Geometry geom)
          Tests whether the base Geometry is within a given geometry.
 

Uses of Geometry in com.vividsolutions.jts.geom.util
 

Methods in com.vividsolutions.jts.geom.util that return Geometry
 Geometry GeometryCombiner.combine()
          Computes the combination of the input geometries to produce the most appropriate Geometry or GeometryCollection
static Geometry GeometryCombiner.combine(Collection geoms)
          Combines a collection of geometries.
static Geometry GeometryCombiner.combine(Geometry g0, Geometry g1)
          Combines two geometries.
static Geometry GeometryCombiner.combine(Geometry g0, Geometry g1, Geometry g2)
          Combines three geometries.
 Geometry SineStarFactory.createSineStar()
          Generates the geometry for the sine star
 Geometry GeometryEditor.edit(Geometry geometry, GeometryEditor.GeometryEditorOperation operation)
          Edit the input Geometry with the given edit operation.
 Geometry GeometryEditor.GeometryEditorOperation.edit(Geometry geometry, GeometryFactory factory)
          Edits a Geometry by returning a new Geometry with a modification.
 Geometry GeometryEditor.NoOpGeometryOperation.edit(Geometry geometry, GeometryFactory factory)
           
 Geometry GeometryEditor.CoordinateOperation.edit(Geometry geometry, GeometryFactory factory)
           
 Geometry GeometryEditor.CoordinateSequenceOperation.edit(Geometry geometry, GeometryFactory factory)
           
 Geometry GeometryTransformer.getInputGeometry()
          Utility function to make input geometry available
 Geometry GeometryMapper.MapOp.map(Geometry g)
          Computes a new geometry value.
static Geometry GeometryMapper.map(Geometry geom, GeometryMapper.MapOp op)
          Maps the members of a Geometry (which may be atomic or composite) into another Geometry of most specific type.
 Geometry GeometryTransformer.transform(Geometry inputGeom)
           
 Geometry AffineTransformation.transform(Geometry g)
          Cretaes a new @link Geometry which is the result of this transformation applied to the input Geometry.
protected  Geometry GeometryTransformer.transformGeometryCollection(GeometryCollection geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformLinearRing(LinearRing geom, Geometry parent)
          Transforms a LinearRing.
protected  Geometry GeometryTransformer.transformLineString(LineString geom, Geometry parent)
          Transforms a LineString geometry.
protected  Geometry GeometryTransformer.transformMultiLineString(MultiLineString geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformMultiPoint(MultiPoint geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformMultiPolygon(MultiPolygon geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformPoint(Point geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformPolygon(Polygon geom, Geometry parent)
           
 

Methods in com.vividsolutions.jts.geom.util with parameters of type Geometry
 void ShortCircuitedGeometryVisitor.applyTo(Geometry geom)
           
static Geometry GeometryCombiner.combine(Geometry g0, Geometry g1)
          Combines two geometries.
static Geometry GeometryCombiner.combine(Geometry g0, Geometry g1, Geometry g2)
          Combines three geometries.
abstract  Coordinate[] GeometryEditor.CoordinateOperation.edit(Coordinate[] coordinates, Geometry geometry)
          Edits the array of Coordinates from a Geometry.
abstract  CoordinateSequence GeometryEditor.CoordinateSequenceOperation.edit(CoordinateSequence coordSeq, Geometry geometry)
          Edits a CoordinateSequence from a Geometry.
 Geometry GeometryEditor.edit(Geometry geometry, GeometryEditor.GeometryEditorOperation operation)
          Edit the input Geometry with the given edit operation.
 Geometry GeometryEditor.GeometryEditorOperation.edit(Geometry geometry, GeometryFactory factory)
          Edits a Geometry by returning a new Geometry with a modification.
 Geometry GeometryEditor.NoOpGeometryOperation.edit(Geometry geometry, GeometryFactory factory)
           
 Geometry GeometryEditor.CoordinateOperation.edit(Geometry geometry, GeometryFactory factory)
           
 Geometry GeometryEditor.CoordinateSequenceOperation.edit(Geometry geometry, GeometryFactory factory)
           
static List GeometryExtracter.extract(Geometry geom, Class clz)
          Extracts the components of type clz from a Geometry and returns them in a List.
static List GeometryExtracter.extract(Geometry geom, Class clz, List list)
          Extracts the components of type clz from a Geometry and adds them to the provided List.
 void PolygonExtracter.filter(Geometry geom)
           
 void PointExtracter.filter(Geometry geom)
           
 void LineStringExtracter.filter(Geometry geom)
           
 void LinearComponentExtracter.filter(Geometry geom)
           
 void GeometryExtracter.filter(Geometry geom)
           
 void ComponentCoordinateExtracter.filter(Geometry geom)
           
static List ComponentCoordinateExtracter.getCoordinates(Geometry geom)
          Extracts the linear components from a single geometry.
static List LineStringExtracter.getLines(Geometry geom)
          Extracts the LineString elements from a single Geometry and returns them in a List.
static List LinearComponentExtracter.getLines(Geometry geom)
          Extracts the linear components from a single geometry.
static List LinearComponentExtracter.getLines(Geometry geom, boolean forceToLineString)
          Extracts the linear components from a single geometry.
static Collection LinearComponentExtracter.getLines(Geometry geom, Collection lines)
          Extracts the linear components from a single Geometry and adds them to the provided Collection.
static Collection LinearComponentExtracter.getLines(Geometry geom, Collection lines, boolean forceToLineString)
          Extracts the linear components from a single Geometry and adds them to the provided Collection.
static List LineStringExtracter.getLines(Geometry geom, List lines)
          Extracts the LineString elements from a single Geometry and adds them to the provided List.
static List PointExtracter.getPoints(Geometry geom)
          Extracts the Point elements from a single Geometry and returns them in a List.
static List PointExtracter.getPoints(Geometry geom, List list)
          Extracts the Point elements from a single Geometry and adds them to the provided List.
static List PolygonExtracter.getPolygons(Geometry geom)
          Extracts the Polygon elements from a single Geometry and returns them in a List.
static List PolygonExtracter.getPolygons(Geometry geom, List list)
          Extracts the Polygon elements from a single Geometry and adds them to the provided List.
 Geometry GeometryMapper.MapOp.map(Geometry g)
          Computes a new geometry value.
static Geometry GeometryMapper.map(Geometry geom, GeometryMapper.MapOp op)
          Maps the members of a Geometry (which may be atomic or composite) into another Geometry of most specific type.
 Geometry GeometryTransformer.transform(Geometry inputGeom)
           
 Geometry AffineTransformation.transform(Geometry g)
          Cretaes a new @link Geometry which is the result of this transformation applied to the input Geometry.
protected  CoordinateSequence GeometryTransformer.transformCoordinates(CoordinateSequence coords, Geometry parent)
          Transforms a CoordinateSequence.
protected  Geometry GeometryTransformer.transformGeometryCollection(GeometryCollection geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformLinearRing(LinearRing geom, Geometry parent)
          Transforms a LinearRing.
protected  Geometry GeometryTransformer.transformLineString(LineString geom, Geometry parent)
          Transforms a LineString geometry.
protected  Geometry GeometryTransformer.transformMultiLineString(MultiLineString geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformMultiPoint(MultiPoint geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformMultiPolygon(MultiPolygon geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformPoint(Point geom, Geometry parent)
           
protected  Geometry GeometryTransformer.transformPolygon(Polygon geom, Geometry parent)
           
protected abstract  void ShortCircuitedGeometryVisitor.visit(Geometry element)
           
 

Uses of Geometry in com.vividsolutions.jts.geomgraph
 

Methods in com.vividsolutions.jts.geomgraph that return Geometry
 Geometry GeometryGraph.getGeometry()
           
 

Constructors in com.vividsolutions.jts.geomgraph with parameters of type Geometry
GeometryGraph(int argIndex, Geometry parentGeom)
           
GeometryGraph(int argIndex, Geometry parentGeom, BoundaryNodeRule boundaryNodeRule)
           
 

Uses of Geometry in com.vividsolutions.jts.io
 

Methods in com.vividsolutions.jts.io that return Geometry
 Geometry WKBReader.read(byte[] bytes)
          Reads a single Geometry in WKB format from a byte array.
 Geometry WKBReader.read(InStream is)
          Reads a Geometry in binary WKB format from an InStream.
 Geometry WKTReader.read(Reader reader)
          Reads a Well-Known Text representation of a Geometry from a Reader.
 Geometry WKTReader.read(String wellKnownText)
          Reads a Well-Known Text representation of a Geometry from a String.
 

Methods in com.vividsolutions.jts.io with parameters of type Geometry
 String WKTWriter.write(Geometry geometry)
          Converts a Geometry to its Well-known Text representation.
 byte[] WKBWriter.write(Geometry geom)
          Writes a Geometry into a byte array.
 void WKBWriter.write(Geometry geom, OutStream os)
          Writes a Geometry to an OutStream.
 void WKTWriter.write(Geometry geometry, Writer writer)
          Converts a Geometry to its Well-known Text representation.
 String WKTWriter.writeFormatted(Geometry geometry)
          Same as write, but with newlines and spaces to make the well-known text more readable.
 void WKTWriter.writeFormatted(Geometry geometry, Writer writer)
          Same as write, but with newlines and spaces to make the well-known text more readable.
 

Uses of Geometry in com.vividsolutions.jts.io.gml2
 

Methods in com.vividsolutions.jts.io.gml2 that return Geometry
 Geometry GMLHandler.getGeometry()
          Gets the geometry parsed by this handler.
 Geometry GMLReader.read(Reader reader, GeometryFactory geometryFactory)
          Reads a GML2 Geometry from a Reader into a single Geometry If a collection of Geometries is found, a GeometryCollection is returned.
 Geometry GMLReader.read(String gml, GeometryFactory geometryFactory)
          Reads a GML2 Geometry from a String into a single Geometry If a collection of geometries is found, a GeometryCollection is returned.
 

Methods in com.vividsolutions.jts.io.gml2 with parameters of type Geometry
 String GMLWriter.write(Geometry geom)
          Writes a Geometry in GML2 format to a String.
 void GMLWriter.write(Geometry geom, Writer writer)
          Writes a Geometry in GML2 format into a Writer.
 

Uses of Geometry in com.vividsolutions.jts.linearref
 

Methods in com.vividsolutions.jts.linearref that return Geometry
 Geometry LengthIndexedLine.extractLine(double startIndex, double endIndex)
          Computes the LineString for the interval on the line between the given indices.
 Geometry LocationIndexedLine.extractLine(LinearLocation startIndex, LinearLocation endIndex)
          Computes the LineString for the interval on the line between the given indices.
 Geometry LinearGeometryBuilder.getGeometry()
           
 

Methods in com.vividsolutions.jts.linearref with parameters of type Geometry
 void LinearLocation.clamp(Geometry linear)
          Ensures the indexes are valid for a given linear Geometry.
 Coordinate LinearLocation.getCoordinate(Geometry linearGeom)
          Gets the Coordinate along the given linear Geometry which is referenced by this location.
static LinearLocation LinearLocation.getEndLocation(Geometry linear)
          Gets a location which refers to the end of a linear Geometry.
static double LengthLocationMap.getLength(Geometry linearGeom, LinearLocation loc)
          Computes the length for a given LinearLocation on a linear Geometry.
static LinearLocation LengthLocationMap.getLocation(Geometry linearGeom, double length)
          Computes the LinearLocation for a given length along a linear Geometry.
static LinearLocation LengthLocationMap.getLocation(Geometry linearGeom, double length, boolean resolveLower)
          Computes the LinearLocation for a given length along a linear Geometry, with control over how the location is resolved at component endpoints.
 LineSegment LinearLocation.getSegment(Geometry linearGeom)
          Gets a LineSegment representing the segment of the given linear Geometry which contains this location.
 double LinearLocation.getSegmentLength(Geometry linearGeom)
          Gets the length of the segment in the given Geometry containing this location.
 LinearLocation[] LocationIndexedLine.indicesOf(Geometry subLine)
          Computes the indices for a subline of the line.
 double[] LengthIndexedLine.indicesOf(Geometry subLine)
          Computes the indices for a subline of the line.
 boolean LinearLocation.isEndpoint(Geometry linearGeom)
          Tests whether this location is an endpoint of the linear component it refers to.
 boolean LinearLocation.isValid(Geometry linearGeom)
          Tests whether this location refers to a valid location on the given linear Geometry.
 void LinearLocation.setToEnd(Geometry linear)
          Sets the value of this location to refer to the end of a linear geometry.
 void LinearLocation.snapToVertex(Geometry linearGeom, double minDistance)
          Snaps the value of this location to the nearest vertex on the given linear Geometry, if the vertex is closer than minDistance.
 

Constructors in com.vividsolutions.jts.linearref with parameters of type Geometry
LengthIndexedLine(Geometry linearGeom)
          Constructs an object which allows a linear Geometry to be linearly referenced using length as an index.
LengthLocationMap(Geometry linearGeom)
           
LinearIterator(Geometry linear)
          Creates an iterator initialized to the start of a linear Geometry
LinearIterator(Geometry linearGeom, int componentIndex, int vertexIndex)
          Creates an iterator starting at a specified component and vertex in a linear Geometry
LinearIterator(Geometry linear, LinearLocation start)
          Creates an iterator starting at a LinearLocation on a linear Geometry
LocationIndexedLine(Geometry linearGeom)
          Constructs an object which allows linear referencing along a given linear Geometry.
 

Uses of Geometry in com.vividsolutions.jts.noding
 

Methods in com.vividsolutions.jts.noding with parameters of type Geometry
static List SegmentStringUtil.extractSegmentStrings(Geometry geom)
          Extracts all linear components from a given Geometry to SegmentStrings.
 

Uses of Geometry in com.vividsolutions.jts.operation
 

Methods in com.vividsolutions.jts.operation that return Geometry
 Geometry GeometryGraphOperation.getArgGeometry(int i)
           
 Geometry BoundaryOp.getBoundary()
           
 

Constructors in com.vividsolutions.jts.operation with parameters of type Geometry
BoundaryOp(Geometry geom)
           
BoundaryOp(Geometry geom, BoundaryNodeRule bnRule)
           
GeometryGraphOperation(Geometry g0)
           
GeometryGraphOperation(Geometry g0, Geometry g1)
           
GeometryGraphOperation(Geometry g0, Geometry g1, BoundaryNodeRule boundaryNodeRule)
           
IsSimpleOp(Geometry geom)
          Creates a simplicity checker using the default SFS Mod-2 Boundary Node Rule
IsSimpleOp(Geometry geom, BoundaryNodeRule boundaryNodeRule)
          Creates a simplicity checker using a given BoundaryNodeRule
 

Uses of Geometry in com.vividsolutions.jts.operation.buffer
 

Methods in com.vividsolutions.jts.operation.buffer that return Geometry
 Geometry BufferBuilder.buffer(Geometry g, double distance)
           
static Geometry BufferOp.bufferOp(Geometry g, double distance)
          Computes the buffer of a geometry for a given buffer distance.
static Geometry BufferOp.bufferOp(Geometry g, double distance, BufferParameters params)
          Comutes the buffer for a geometry for a given buffer distance and accuracy of approximation.
static Geometry BufferOp.bufferOp(Geometry g, double distance, int quadrantSegments)
          Comutes the buffer for a geometry for a given buffer distance and accuracy of approximation.
static Geometry BufferOp.bufferOp(Geometry g, double distance, int quadrantSegments, int endCapStyle)
          Comutes the buffer for a geometry for a given buffer distance and accuracy of approximation.
 Geometry BufferOp.getResultGeometry(double distance)
          Returns the buffer computed for a geometry for a given buffer distance.
 

Methods in com.vividsolutions.jts.operation.buffer with parameters of type Geometry
 Geometry BufferBuilder.buffer(Geometry g, double distance)
           
static Geometry BufferOp.bufferOp(Geometry g, double distance)
          Computes the buffer of a geometry for a given buffer distance.
static Geometry BufferOp.bufferOp(Geometry g, double distance, BufferParameters params)
          Comutes the buffer for a geometry for a given buffer distance and accuracy of approximation.
static Geometry BufferOp.bufferOp(Geometry g, double distance, int quadrantSegments)
          Comutes the buffer for a geometry for a given buffer distance and accuracy of approximation.
static Geometry BufferOp.bufferOp(Geometry g, double distance, int quadrantSegments, int endCapStyle)
          Comutes the buffer for a geometry for a given buffer distance and accuracy of approximation.
 

Constructors in com.vividsolutions.jts.operation.buffer with parameters of type Geometry
BufferOp(Geometry g)
          Initializes a buffer computation for the given geometry
BufferOp(Geometry g, BufferParameters bufParams)
          Initializes a buffer computation for the given geometry with the given set of parameters
OffsetCurveSetBuilder(Geometry inputGeom, double distance, OffsetCurveBuilder curveBuilder)
           
 

Uses of Geometry in com.vividsolutions.jts.operation.buffer.validate
 

Methods in com.vividsolutions.jts.operation.buffer.validate that return Geometry
 Geometry BufferResultValidator.getErrorIndicator()
          Gets a geometry which indicates the location and nature of a validation failure.
 Geometry BufferDistanceValidator.getErrorIndicator()
          Gets a geometry which indicates the location and nature of a validation failure.
 

Methods in com.vividsolutions.jts.operation.buffer.validate with parameters of type Geometry
static void DistanceToPointFinder.computeDistance(Geometry geom, Coordinate pt, PointPairDistance ptDist)
           
 double BufferCurveMaximumDistanceFinder.findDistance(Geometry bufferCurve)
           
static boolean BufferResultValidator.isValid(Geometry g, double distance, Geometry result)
           
static String BufferResultValidator.isValidMsg(Geometry g, double distance, Geometry result)
          Checks whether the geometry buffer is valid, and returns an error message if not.
 

Constructors in com.vividsolutions.jts.operation.buffer.validate with parameters of type Geometry
BufferCurveMaximumDistanceFinder.MaxMidpointDistanceFilter(Geometry geom)
           
BufferCurveMaximumDistanceFinder.MaxPointDistanceFilter(Geometry geom)
           
BufferCurveMaximumDistanceFinder(Geometry inputGeom)
           
BufferDistanceValidator(Geometry input, double bufDistance, Geometry result)
           
BufferResultValidator(Geometry input, double distance, Geometry result)
           
 

Uses of Geometry in com.vividsolutions.jts.operation.distance
 

Methods in com.vividsolutions.jts.operation.distance that return Geometry
 Geometry GeometryLocation.getGeometryComponent()
          Returns the geometry component on (or in) which this location occurs.
 

Methods in com.vividsolutions.jts.operation.distance with parameters of type Geometry
static STRtree FacetSequenceTreeBuilder.build(Geometry g)
           
static Coordinate[] DistanceOp.closestPoints(Geometry g0, Geometry g1)
          Deprecated. renamed to nearestPoints
static double IndexedFacetDistance.distance(Geometry g1, Geometry g2)
          Computes the distance between two geometries using the indexed approach.
static double DistanceOp.distance(Geometry g0, Geometry g1)
          Compute the distance between the nearest points of two geometries.
 void ConnectedElementPointFilter.filter(Geometry geom)
           
 void ConnectedElementLocationFilter.filter(Geometry geom)
           
static List ConnectedElementPointFilter.getCoordinates(Geometry geom)
          Returns a list containing a Coordinate from each Polygon, LineString, and Point found inside the specified geometry.
 double IndexedFacetDistance.getDistance(Geometry g)
          Computes the distance from the base geometry to the given geometry.
static List ConnectedElementLocationFilter.getLocations(Geometry geom)
          Returns a list containing a point from each Polygon, LineString, and Point found inside the specified geometry.
static boolean DistanceOp.isWithinDistance(Geometry g0, Geometry g1, double distance)
          Test whether two geometries lie within a given distance of each other.
static Coordinate[] DistanceOp.nearestPoints(Geometry g0, Geometry g1)
          Compute the the nearest points of two geometries.
 

Constructors in com.vividsolutions.jts.operation.distance with parameters of type Geometry
DistanceOp(Geometry g0, Geometry g1)
          Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries.
DistanceOp(Geometry g0, Geometry g1, double terminateDistance)
          Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries.
GeometryLocation(Geometry component, Coordinate pt)
          Constructs a GeometryLocation specifying a point inside an area geometry.
GeometryLocation(Geometry component, int segIndex, Coordinate pt)
          Constructs a GeometryLocation specifying a point on a geometry, as well as the segment that the point is on (or GeometryLocation.INSIDE_AREA if the point is not on a segment).
IndexedFacetDistance(Geometry g1)
          Creates a new distance-finding instance for a given target Geometry.
 

Uses of Geometry in com.vividsolutions.jts.operation.distance3d
 

Methods in com.vividsolutions.jts.operation.distance3d with parameters of type Geometry
static double Distance3DOp.distance(Geometry g0, Geometry g1)
          Compute the distance between the nearest points of two geometries.
static boolean Distance3DOp.isWithinDistance(Geometry g0, Geometry g1, double distance)
          Test whether two geometries lie within a given distance of each other.
static Coordinate[] Distance3DOp.nearestPoints(Geometry g0, Geometry g1)
          Compute the the nearest points of two geometries.
 

Constructors in com.vividsolutions.jts.operation.distance3d with parameters of type Geometry
Distance3DOp(Geometry g0, Geometry g1)
          Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries.
Distance3DOp(Geometry g0, Geometry g1, double terminateDistance)
          Constructs a DistanceOp that computes the distance and nearest points between the two specified geometries.
 

Uses of Geometry in com.vividsolutions.jts.operation.linemerge
 

Methods in com.vividsolutions.jts.operation.linemerge that return Geometry
 Geometry LineSequencer.getSequencedLineStrings()
          Returns the LineString or MultiLineString built by the sequencing process, if one exists.
static Geometry LineSequencer.sequence(Geometry geom)
           
 

Methods in com.vividsolutions.jts.operation.linemerge with parameters of type Geometry
 void LineSequencer.add(Geometry geometry)
          Adds a Geometry to be sequenced.
 void LineMerger.add(Geometry geometry)
          Adds a Geometry to be processed.
static boolean LineSequencer.isSequenced(Geometry geom)
          Tests whether a Geometry is sequenced correctly.
static Geometry LineSequencer.sequence(Geometry geom)
           
 

Uses of Geometry in com.vividsolutions.jts.operation.overlay
 

Methods in com.vividsolutions.jts.operation.overlay that return Geometry
static Geometry OverlayOp.createEmptyResult(int opCode, Geometry a, Geometry b, GeometryFactory geomFact)
          Creates an empty result geometry of the appropriate dimension, based on the dimensions of the inputs.
 Geometry OverlayOp.getResultGeometry(int funcCode)
           
static Geometry OverlayOp.overlayOp(Geometry geom0, Geometry geom1, int opCode)
           
 

Methods in com.vividsolutions.jts.operation.overlay with parameters of type Geometry
static Geometry OverlayOp.createEmptyResult(int opCode, Geometry a, Geometry b, GeometryFactory geomFact)
          Creates an empty result geometry of the appropriate dimension, based on the dimensions of the inputs.
static Geometry OverlayOp.overlayOp(Geometry geom0, Geometry geom1, int opCode)
           
 

Constructors in com.vividsolutions.jts.operation.overlay with parameters of type Geometry
OverlayOp(Geometry g0, Geometry g1)
           
 

Uses of Geometry in com.vividsolutions.jts.operation.overlay.snap
 

Methods in com.vividsolutions.jts.operation.overlay.snap that return Geometry
static Geometry SnapOverlayOp.difference(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.difference(Geometry g0, Geometry g1)
           
 Geometry SnapOverlayOp.getResultGeometry(int opCode)
           
 Geometry SnapIfNeededOverlayOp.getResultGeometry(int opCode)
           
static Geometry SnapOverlayOp.intersection(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.intersection(Geometry g0, Geometry g1)
           
static Geometry SnapOverlayOp.overlayOp(Geometry g0, Geometry g1, int opCode)
           
static Geometry SnapIfNeededOverlayOp.overlayOp(Geometry g0, Geometry g1, int opCode)
           
static Geometry[] GeometrySnapper.snap(Geometry g0, Geometry g1, double snapTolerance)
          Snaps two geometries together with a given tolerance.
 Geometry GeometrySnapper.snapTo(Geometry snapGeom, double snapTolerance)
          Snaps the vertices in the component LineStrings of the source geometry to the vertices of the given snap geometry.
 Geometry GeometrySnapper.snapToSelf(double snapTolerance, boolean cleanResult)
          Snaps the vertices in the component LineStrings of the source geometry to the vertices of the given snap geometry.
static Geometry GeometrySnapper.snapToSelf(Geometry g0, double snapTolerance, boolean cleanResult)
           
static Geometry SnapOverlayOp.symDifference(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.symDifference(Geometry g0, Geometry g1)
           
static Geometry SnapOverlayOp.union(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.union(Geometry g0, Geometry g1)
           
 

Methods in com.vividsolutions.jts.operation.overlay.snap with parameters of type Geometry
static double GeometrySnapper.computeOverlaySnapTolerance(Geometry g)
          Estimates the snap tolerance for a Geometry, taking into account its precision model.
static double GeometrySnapper.computeOverlaySnapTolerance(Geometry g0, Geometry g1)
           
static double GeometrySnapper.computeSizeBasedSnapTolerance(Geometry g)
           
static Geometry SnapOverlayOp.difference(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.difference(Geometry g0, Geometry g1)
           
 Coordinate[] GeometrySnapper.extractTargetCoordinates(Geometry g)
           
static Geometry SnapOverlayOp.intersection(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.intersection(Geometry g0, Geometry g1)
           
static Geometry SnapOverlayOp.overlayOp(Geometry g0, Geometry g1, int opCode)
           
static Geometry SnapIfNeededOverlayOp.overlayOp(Geometry g0, Geometry g1, int opCode)
           
static Geometry[] GeometrySnapper.snap(Geometry g0, Geometry g1, double snapTolerance)
          Snaps two geometries together with a given tolerance.
 Geometry GeometrySnapper.snapTo(Geometry snapGeom, double snapTolerance)
          Snaps the vertices in the component LineStrings of the source geometry to the vertices of the given snap geometry.
static Geometry GeometrySnapper.snapToSelf(Geometry g0, double snapTolerance, boolean cleanResult)
           
static Geometry SnapOverlayOp.symDifference(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.symDifference(Geometry g0, Geometry g1)
           
static Geometry SnapOverlayOp.union(Geometry g0, Geometry g1)
           
static Geometry SnapIfNeededOverlayOp.union(Geometry g0, Geometry g1)
           
 

Constructors in com.vividsolutions.jts.operation.overlay.snap with parameters of type Geometry
GeometrySnapper(Geometry srcGeom)
          Creates a new snapper acting on the given geometry
SnapIfNeededOverlayOp(Geometry g1, Geometry g2)
           
SnapOverlayOp(Geometry g1, Geometry g2)
           
 

Uses of Geometry in com.vividsolutions.jts.operation.overlay.validate
 

Methods in com.vividsolutions.jts.operation.overlay.validate with parameters of type Geometry
static boolean OverlayResultValidator.isValid(Geometry a, Geometry b, int overlayOp, Geometry result)
           
 

Constructors in com.vividsolutions.jts.operation.overlay.validate with parameters of type Geometry
FuzzyPointLocator(Geometry g, double boundaryDistanceTolerance)
           
OffsetPointGenerator(Geometry g)
           
OverlayResultValidator(Geometry a, Geometry b, Geometry result)
           
 

Uses of Geometry in com.vividsolutions.jts.operation.polygonize
 

Methods in com.vividsolutions.jts.operation.polygonize with parameters of type Geometry
 void Polygonizer.add(Geometry g)
          Add a Geometry to the edges to be polygonized.
 

Uses of Geometry in com.vividsolutions.jts.operation.predicate
 

Methods in com.vividsolutions.jts.operation.predicate with parameters of type Geometry
 boolean RectangleContains.contains(Geometry geom)
           
static boolean RectangleContains.contains(Polygon rectangle, Geometry b)
          Tests whether a rectangle contains a given geometry.
 boolean RectangleIntersects.intersects(Geometry geom)
          Tests whether the given Geometry intersects the query rectangle.
static boolean RectangleIntersects.intersects(Polygon rectangle, Geometry b)
          Tests whether a rectangle intersects a given geometry.
 

Uses of Geometry in com.vividsolutions.jts.operation.relate
 

Methods in com.vividsolutions.jts.operation.relate with parameters of type Geometry
static IntersectionMatrix RelateOp.relate(Geometry a, Geometry b)
          Computes the IntersectionMatrix for the spatial relationship between two Geometrys, using the default (OGC SFS) Boundary Node Rule
static IntersectionMatrix RelateOp.relate(Geometry a, Geometry b, BoundaryNodeRule boundaryNodeRule)
          Computes the IntersectionMatrix for the spatial relationship between two Geometrys using a specified Boundary Node Rule.
 

Constructors in com.vividsolutions.jts.operation.relate with parameters of type Geometry
RelateOp(Geometry g0, Geometry g1)
          Creates a new Relate operation, using the default (OGC SFS) Boundary Node Rule.
RelateOp(Geometry g0, Geometry g1, BoundaryNodeRule boundaryNodeRule)
          Creates a new Relate operation with a specified Boundary Node Rule.
 

Uses of Geometry in com.vividsolutions.jts.operation.union
 

Methods in com.vividsolutions.jts.operation.union that return Geometry
 Geometry UnionInteracting.union()
           
 Geometry UnaryUnionOp.union()
          Gets the union of the input geometries.
 Geometry PointGeometryUnion.union()
           
 Geometry CascadedPolygonUnion.union()
          Computes the union of the input geometries.
static Geometry UnaryUnionOp.union(Collection geoms)
           
static Geometry CascadedPolygonUnion.union(Collection polys)
          Computes the union of a collection of Polygonal Geometrys.
static Geometry UnaryUnionOp.union(Collection geoms, GeometryFactory geomFact)
           
static Geometry UnaryUnionOp.union(Geometry geom)
           
static Geometry UnionInteracting.union(Geometry g0, Geometry g1)
           
static Geometry PointGeometryUnion.union(Puntal pointGeom, Geometry otherGeom)
           
 

Methods in com.vividsolutions.jts.operation.union with parameters of type Geometry
static Geometry UnaryUnionOp.union(Geometry geom)
           
static Geometry UnionInteracting.union(Geometry g0, Geometry g1)
           
static Geometry PointGeometryUnion.union(Puntal pointGeom, Geometry otherGeom)
           
 

Constructors in com.vividsolutions.jts.operation.union with parameters of type Geometry
PointGeometryUnion(Puntal pointGeom, Geometry otherGeom)
           
UnaryUnionOp(Geometry geom)
           
UnionInteracting(Geometry g0, Geometry g1)
           
 

Uses of Geometry in com.vividsolutions.jts.operation.valid
 

Methods in com.vividsolutions.jts.operation.valid with parameters of type Geometry
 boolean RepeatedPointTester.hasRepeatedPoint(Geometry g)
           
static boolean IsValidOp.isValid(Geometry geom)
          Tests whether a Geometry is valid.
 

Constructors in com.vividsolutions.jts.operation.valid with parameters of type Geometry
IsValidOp(Geometry parentGeometry)
           
 

Uses of Geometry in com.vividsolutions.jts.precision
 

Methods in com.vividsolutions.jts.precision that return Geometry
static Geometry EnhancedPrecisionOp.buffer(Geometry geom, double distance)
          Computes the buffer of a Geometry, using enhanced precision.
 Geometry CommonBitsOp.buffer(Geometry geom0, double distance)
          Computes the buffer a geometry, using enhanced precision.
static Geometry EnhancedPrecisionOp.difference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic difference of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.difference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic difference of two Geometrys, using enhanced precision.
static Geometry SimpleMinimumClearance.getLine(Geometry g)
           
static Geometry MinimumClearance.getLine(Geometry g)
          Gets a LineString containing two points which are at the Minimum Clearance distance for the given Geometry.
static Geometry EnhancedPrecisionOp.intersection(Geometry geom0, Geometry geom1)
          Computes the set-theoretic intersection of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.intersection(Geometry geom0, Geometry geom1)
          Computes the set-theoretic intersection of two Geometrys, using enhanced precision.
 Geometry SimpleGeometryPrecisionReducer.reduce(Geometry geom)
          Deprecated.  
 Geometry GeometryPrecisionReducer.reduce(Geometry geom)
           
static Geometry SimpleGeometryPrecisionReducer.reduce(Geometry g, PrecisionModel precModel)
          Deprecated. Convenience method for doing precision reduction on a single geometry, with collapses removed and keeping the geometry precision model the same.
static Geometry GeometryPrecisionReducer.reduce(Geometry g, PrecisionModel precModel)
          Convenience method for doing precision reduction on a single geometry, with collapses removed and keeping the geometry precision model the same, and preserving polygonal topology.
static Geometry GeometryPrecisionReducer.reducePointwise(Geometry g, PrecisionModel precModel)
          Convenience method for doing pointwise precision reduction on a single geometry, with collapses removed and keeping the geometry precision model the same, but NOT preserving valid polygonal topology.
 Geometry CommonBitsRemover.removeCommonBits(Geometry geom)
          Removes the common coordinate bits from a Geometry.
static Geometry EnhancedPrecisionOp.symDifference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic symmetric difference of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.symDifference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic symmetric difference of two geometries, using enhanced precision.
static Geometry EnhancedPrecisionOp.union(Geometry geom0, Geometry geom1)
          Computes the set-theoretic union of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.union(Geometry geom0, Geometry geom1)
          Computes the set-theoretic union of two Geometrys, using enhanced precision.
 

Methods in com.vividsolutions.jts.precision with parameters of type Geometry
 void CommonBitsRemover.add(Geometry geom)
          Add a geometry to the set of geometries whose common bits are being computed.
 void CommonBitsRemover.addCommonBits(Geometry geom)
          Adds the common coordinate bits back into a Geometry.
static Geometry EnhancedPrecisionOp.buffer(Geometry geom, double distance)
          Computes the buffer of a Geometry, using enhanced precision.
 Geometry CommonBitsOp.buffer(Geometry geom0, double distance)
          Computes the buffer a geometry, using enhanced precision.
static Geometry EnhancedPrecisionOp.difference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic difference of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.difference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic difference of two Geometrys, using enhanced precision.
 Coordinate[] PrecisionReducerCoordinateOperation.edit(Coordinate[] coordinates, Geometry geom)
           
static double SimpleMinimumClearance.getDistance(Geometry g)
           
static double MinimumClearance.getDistance(Geometry g)
          Computes the Minimum Clearance distance for the given Geometry.
static Geometry SimpleMinimumClearance.getLine(Geometry g)
           
static Geometry MinimumClearance.getLine(Geometry g)
          Gets a LineString containing two points which are at the Minimum Clearance distance for the given Geometry.
static Geometry EnhancedPrecisionOp.intersection(Geometry geom0, Geometry geom1)
          Computes the set-theoretic intersection of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.intersection(Geometry geom0, Geometry geom1)
          Computes the set-theoretic intersection of two Geometrys, using enhanced precision.
 Geometry SimpleGeometryPrecisionReducer.reduce(Geometry geom)
          Deprecated.  
 Geometry GeometryPrecisionReducer.reduce(Geometry geom)
           
static Geometry SimpleGeometryPrecisionReducer.reduce(Geometry g, PrecisionModel precModel)
          Deprecated. Convenience method for doing precision reduction on a single geometry, with collapses removed and keeping the geometry precision model the same.
static Geometry GeometryPrecisionReducer.reduce(Geometry g, PrecisionModel precModel)
          Convenience method for doing precision reduction on a single geometry, with collapses removed and keeping the geometry precision model the same, and preserving polygonal topology.
static Geometry GeometryPrecisionReducer.reducePointwise(Geometry g, PrecisionModel precModel)
          Convenience method for doing pointwise precision reduction on a single geometry, with collapses removed and keeping the geometry precision model the same, but NOT preserving valid polygonal topology.
 Geometry CommonBitsRemover.removeCommonBits(Geometry geom)
          Removes the common coordinate bits from a Geometry.
static Geometry EnhancedPrecisionOp.symDifference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic symmetric difference of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.symDifference(Geometry geom0, Geometry geom1)
          Computes the set-theoretic symmetric difference of two geometries, using enhanced precision.
static Geometry EnhancedPrecisionOp.union(Geometry geom0, Geometry geom1)
          Computes the set-theoretic union of two Geometrys, using enhanced precision.
 Geometry CommonBitsOp.union(Geometry geom0, Geometry geom1)
          Computes the set-theoretic union of two Geometrys, using enhanced precision.
 

Constructors in com.vividsolutions.jts.precision with parameters of type Geometry
MinimumClearance(Geometry geom)
          Creates an object to compute the Minimum Clearance for the given Geometry
SimpleMinimumClearance(Geometry geom)
           
 

Uses of Geometry in com.vividsolutions.jts.shape
 

Methods in com.vividsolutions.jts.shape that return Geometry
abstract  Geometry GeometricShapeBuilder.getGeometry()
           
 

Uses of Geometry in com.vividsolutions.jts.shape.fractal
 

Methods in com.vividsolutions.jts.shape.fractal that return Geometry
 Geometry SierpinskiCarpetBuilder.getGeometry()
           
 Geometry KochSnowflakeBuilder.getGeometry()
           
 

Uses of Geometry in com.vividsolutions.jts.shape.random
 

Fields in com.vividsolutions.jts.shape.random declared as Geometry
protected  Geometry RandomPointsBuilder.maskPoly
           
 

Methods in com.vividsolutions.jts.shape.random that return Geometry
 Geometry RandomPointsInGridBuilder.getGeometry()
          Gets the MultiPoint containing the generated point
 Geometry RandomPointsBuilder.getGeometry()
           
 

Methods in com.vividsolutions.jts.shape.random with parameters of type Geometry
 void RandomPointsBuilder.setExtent(Geometry mask)
          Sets a polygonal mask.
 

Uses of Geometry in com.vividsolutions.jts.simplify
 

Methods in com.vividsolutions.jts.simplify that return Geometry
 Geometry TopologyPreservingSimplifier.getResultGeometry()
           
 Geometry DouglasPeuckerSimplifier.getResultGeometry()
           
static Geometry TopologyPreservingSimplifier.simplify(Geometry geom, double distanceTolerance)
           
static Geometry DouglasPeuckerSimplifier.simplify(Geometry geom, double distanceTolerance)
           
 

Methods in com.vividsolutions.jts.simplify with parameters of type Geometry
static Geometry TopologyPreservingSimplifier.simplify(Geometry geom, double distanceTolerance)
           
static Geometry DouglasPeuckerSimplifier.simplify(Geometry geom, double distanceTolerance)
           
 

Constructors in com.vividsolutions.jts.simplify with parameters of type Geometry
DouglasPeuckerSimplifier(Geometry inputGeom)
           
TopologyPreservingSimplifier(Geometry inputGeom)
           
 

Uses of Geometry in com.vividsolutions.jts.triangulate
 

Methods in com.vividsolutions.jts.triangulate that return Geometry
 Geometry ConformingDelaunayTriangulator.getConvexHull()
          Gets the convex hull of all the sites in the triangulation, including constraint vertices.
 Geometry VoronoiDiagramBuilder.getDiagram(GeometryFactory geomFact)
          Gets the faces of the computed diagram as a GeometryCollection of Polygons, clipped as specified.
 Geometry DelaunayTriangulationBuilder.getEdges(GeometryFactory geomFact)
          Gets the edges of the computed triangulation as a MultiLineString.
 Geometry ConformingDelaunayTriangulationBuilder.getEdges(GeometryFactory geomFact)
          Gets the edges of the computed triangulation as a MultiLineString.
 Geometry DelaunayTriangulationBuilder.getTriangles(GeometryFactory geomFact)
          Gets the faces of the computed triangulation as a GeometryCollection of Polygon.
 Geometry ConformingDelaunayTriangulationBuilder.getTriangles(GeometryFactory geomFact)
          Gets the faces of the computed triangulation as a GeometryCollection of Polygon.
 

Methods in com.vividsolutions.jts.triangulate with parameters of type Geometry
static CoordinateList DelaunayTriangulationBuilder.extractUniqueCoordinates(Geometry geom)
          Extracts the unique Coordinates from the given Geometry.
 void VertexTaggedGeometryDataMapper.loadSourceGeometries(Geometry geomColl)
           
 void ConformingDelaunayTriangulationBuilder.setConstraints(Geometry constraintLines)
          Sets the linear constraints to be conformed to.
 void VoronoiDiagramBuilder.setSites(Geometry geom)
          Sets the sites (point or vertices) which will be diagrammed.
 void DelaunayTriangulationBuilder.setSites(Geometry geom)
          Sets the sites (vertices) which will be triangulated.
 void ConformingDelaunayTriangulationBuilder.setSites(Geometry geom)
          Sets the sites (point or vertices) which will be triangulated.
 void VertexTaggedGeometryDataMapper.transferData(Geometry targetGeom)
          Input is assumed to be a multiGeometry in which every component has its userData set to be a Coordinate which is the key to the output data.
 

Uses of Geometry in com.vividsolutions.jts.triangulate.quadedge
 

Methods in com.vividsolutions.jts.triangulate.quadedge that return Geometry
 Geometry QuadEdgeSubdivision.getEdges(GeometryFactory geomFact)
          Gets the geometry for the edges in the subdivision as a MultiLineString containing 2-point lines.
 Geometry QuadEdgeSubdivision.getTriangles(GeometryFactory geomFact)
          Gets the geometry for the triangles in a triangulated subdivision as a GeometryCollection of triangular Polygons.
 Geometry QuadEdgeSubdivision.getVoronoiDiagram(GeometryFactory geomFact)
          Gets the cells in the Voronoi diagram for this triangulation.
static Geometry QuadEdgeTriangle.toPolygon(QuadEdge[] e)
           
static Geometry QuadEdgeTriangle.toPolygon(Vertex[] v)
           
 

Uses of Geometry in com.vividsolutions.jts.util
 

Methods in com.vividsolutions.jts.util that return Geometry
protected  Geometry GeometricShapeFactory.rotate(Geometry geom)
           
 

Methods in com.vividsolutions.jts.util with parameters of type Geometry
static boolean Debug.hasSegment(Geometry geom, Coordinate p0, Coordinate p1)
           
protected  Geometry GeometricShapeFactory.rotate(Geometry geom)
           
 

Uses of Geometry in com.vividsolutions.jtsexample.technique
 

Methods in com.vividsolutions.jtsexample.technique that return Geometry
static Geometry LineStringSelfIntersections.getEndPoints(Geometry g)
           
static Geometry LineStringSelfIntersections.lineStringSelfIntersections(LineString line)
           
 

Methods in com.vividsolutions.jtsexample.technique with parameters of type Geometry
static Geometry LineStringSelfIntersections.getEndPoints(Geometry g)
           
static void PolygonUnionUsingBuffer.unionUsingBuffer(Geometry[] geom)
          Deprecated.  
 



Copyright © 2012. All Rights Reserved.