QGIS API Documentation  2.2.0-Valmiera
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Groups Pages
Classes | Public Member Functions | Static Public Member Functions | Private Member Functions | Static Private Member Functions | Private Attributes | List of all members
QgsGeometry Class Reference

#include <qgsgeometry.h>

Classes

class  Error

Public Member Functions

 QgsGeometry ()
 Constructor.
 QgsGeometry (const QgsGeometry &)
 copy constructor will prompt a deep copy of the object
QgsGeometryoperator= (QgsGeometry const &rhs)
 assignments will prompt a deep copy of the object
 ~QgsGeometry ()
 Destructor.
void fromGeos (GEOSGeometry *geos)
 Set the geometry, feeding in a geometry in GEOS format.
void fromWkb (unsigned char *wkb, size_t length)
 Set the geometry, feeding in the buffer containing OGC Well-Known Binary and the buffer's length.
const unsigned char * asWkb () const
 Returns the buffer containing this geometry in WKB format.
size_t wkbSize () const
 Returns the size of the WKB in asWkb().
const GEOSGeometry * asGeos () const
 Returns a geos geomtry.
QGis::WkbType wkbType () const
 Returns type of wkb (point / linestring / polygon etc.)
QGis::GeometryType type ()
 Returns type of the vector.
bool isMultipart ()
 Returns true if wkb of the geometry is of WKBMulti* type.
bool isGeosEqual (QgsGeometry &)
 compare geometries using GEOS
bool isGeosValid ()
 check validity using GEOS
bool isGeosEmpty ()
 check if geometry is empty using GEOS
double area ()
 get area of geometry using GEOS
double length ()
 get length of geometry using GEOS
double distance (QgsGeometry &geom)
QgsPoint closestVertex (const QgsPoint &point, int &atVertex, int &beforeVertex, int &afterVertex, double &sqrDist)
 Returns the vertex closest to the given point, the corresponding vertex index, squared distance snap point / target point and the indices of the vertices before/after.
void adjacentVertices (int atVertex, int &beforeVertex, int &afterVertex)
 Returns the indexes of the vertices before and after the given vertex index.
bool insertVertex (double x, double y, int beforeVertex)
 Insert a new vertex before the given vertex index, ring and item (first number is index 0) If the requested vertex number (beforeVertex.back()) is greater than the last actual vertex on the requested ring and item, it is assumed that the vertex is to be appended instead of inserted.
bool moveVertex (double x, double y, int atVertex)
 Moves the vertex at the given position number and item (first number is index 0) to the given coordinates.
bool deleteVertex (int atVertex)
 Deletes the vertex at the given position number and item (first number is index 0) Returns false if atVertex does not correspond to a valid vertex on this geometry (including if this geometry is a Point), or if the number of remaining verticies in the linestring would be less than two.
QgsPoint vertexAt (int atVertex)
 Returns coordinates of a vertex.
double sqrDistToVertexAt (QgsPoint &point, int atVertex)
 Returns the squared cartesian distance between the given point to the given vertex index (vertex at the given position number, ring and item (first number is index 0))
double closestVertexWithContext (const QgsPoint &point, int &atVertex)
 Searches for the closest vertex in this geometry to the given point.
double closestSegmentWithContext (const QgsPoint &point, QgsPoint &minDistPoint, int &afterVertex, double *leftOf=0, double epsilon=DEFAULT_SEGMENT_EPSILON)
 Searches for the closest segment of geometry to the given point.
int addRing (const QList< QgsPoint > &ring)
 Adds a new ring to this geometry.
int addPart (const QList< QgsPoint > &points, QGis::GeometryType geomType=QGis::UnknownGeometry)
 Adds a new island polygon to a multipolygon feature.
int addPart (GEOSGeometry *newPart)
 Adds a new island polygon to a multipolygon feature.
int addPart (QgsGeometry *newPart)
 Adds a new island polygon to a multipolygon feature.
int translate (double dx, double dy)
 Translate this geometry by dx, dy.
int transform (const QgsCoordinateTransform &ct)
 Transform this geometry as described by CoordinateTranasform ct.
int splitGeometry (const QList< QgsPoint > &splitLine, QList< QgsGeometry * > &newGeometries, bool topological, QList< QgsPoint > &topologyTestPoints)
 Splits this geometry according to a given line.
int reshapeGeometry (const QList< QgsPoint > &reshapeWithLine)
 Replaces a part of this geometry with another line.
int makeDifference (QgsGeometry *other)
 Changes this geometry such that it does not intersect the other geometry.
QgsRectangle boundingBox ()
 Returns the bounding box of this feature.
bool intersects (const QgsRectangle &r) const
 Test for intersection with a rectangle (uses GEOS)
bool intersects (const QgsGeometry *geometry) const
 Test for intersection with a geometry (uses GEOS)
bool contains (const QgsPoint *p) const
 Test for containment of a point (uses GEOS)
bool contains (const QgsGeometry *geometry) const
 Test for if geometry is contained in another (uses GEOS)
bool disjoint (const QgsGeometry *geometry) const
 Test for if geometry is disjoint of another (uses GEOS)
bool equals (const QgsGeometry *geometry) const
 Test for if geometry equals another (uses GEOS)
bool touches (const QgsGeometry *geometry) const
 Test for if geometry touch another (uses GEOS)
bool overlaps (const QgsGeometry *geometry) const
 Test for if geometry overlaps another (uses GEOS)
bool within (const QgsGeometry *geometry) const
 Test for if geometry is within another (uses GEOS)
bool crosses (const QgsGeometry *geometry) const
 Test for if geometry crosses another (uses GEOS)
QgsGeometrybuffer (double distance, int segments)
 Returns a buffer region around this geometry having the given width and with a specified number of segments used to approximate curves.
QgsGeometrysimplify (double tolerance)
 Returns a simplified version of this geometry using a specified tolerance value.
QgsGeometrycentroid ()
 Returns the center of mass of a geometry.
QgsGeometryconvexHull ()
 Returns the smallest convex polygon that contains all the points in the geometry.
QgsGeometryinterpolate (double distance)
QgsGeometryintersection (QgsGeometry *geometry)
 Returns a geometry representing the points shared by this geometry and other.
QgsGeometrycombine (QgsGeometry *geometry)
 Returns a geometry representing all the points in this geometry and other (a union geometry operation).
QgsGeometrydifference (QgsGeometry *geometry)
 Returns a geometry representing the points making up this geometry that do not make up other.
QgsGeometrysymDifference (QgsGeometry *geometry)
 Returns a Geometry representing the points making up this Geometry that do not make up other.
QString exportToWkt () const
 Exports the geometry to mWkt.
QString exportToGeoJSON () const
 Exports the geometry to mGeoJSON.
QgsPoint asPoint () const
 return contents of the geometry as a point if wkbType is WKBPoint, otherwise returns [0,0]
QgsPolyline asPolyline () const
 return contents of the geometry as a polyline if wkbType is WKBLineString, otherwise an empty list
QgsPolygon asPolygon () const
 return contents of the geometry as a polygon if wkbType is WKBPolygon, otherwise an empty list
QgsMultiPoint asMultiPoint () const
 return contents of the geometry as a multi point if wkbType is WKBMultiPoint, otherwise an empty list
QgsMultiPolyline asMultiPolyline () const
 return contents of the geometry as a multi linestring if wkbType is WKBMultiLineString, otherwise an empty list
QgsMultiPolygon asMultiPolygon () const
 return contents of the geometry as a multi polygon if wkbType is WKBMultiPolygon, otherwise an empty list
QList< QgsGeometry * > asGeometryCollection () const
 return contents of the geometry as a list of geometries
bool deleteRing (int ringNum, int partNum=0)
 delete a ring in polygon or multipolygon.
bool deletePart (int partNum)
 delete part identified by the part number
bool convertToMultiType ()
 Converts single type geometry into multitype geometry e.g.
int avoidIntersections (QMap< QgsVectorLayer *, QSet< QgsFeatureId > > ignoreFeatures=(QMap< QgsVectorLayer *, QSet< QgsFeatureId > >()))
 Modifies geometry to avoid intersections with the layers specified in project properties.
void validateGeometry (QList< Error > &errors)
 Validate geometry and produce a list of geometry errors.

Static Public Member Functions

static QgsGeometryfromWkt (QString wkt)
 static method that creates geometry from Wkt
static QgsGeometryfromPoint (const QgsPoint &point)
 construct geometry from a point
static QgsGeometryfromMultiPoint (const QgsMultiPoint &multipoint)
 construct geometry from a multipoint
static QgsGeometryfromPolyline (const QgsPolyline &polyline)
 construct geometry from a polyline
static QgsGeometryfromMultiPolyline (const QgsMultiPolyline &multiline)
 construct geometry from a multipolyline
static QgsGeometryfromPolygon (const QgsPolygon &polygon)
 construct geometry from a polygon
static QgsGeometryfromMultiPolygon (const QgsMultiPolygon &multipoly)
 construct geometry from a multipolygon
static QgsGeometryfromRect (const QgsRectangle &rect)
 construct geometry from a rectangle

Private Member Functions

bool exportWkbToGeos () const
 Converts from the WKB geometry to the GEOS geometry.
bool exportGeosToWkb () const
 Converts from the GEOS geometry to the WKB geometry.
bool insertVertex (double x, double y, int beforeVertex, const GEOSCoordSequence *old_sequence, GEOSCoordSequence **new_sequence)
 Insert a new vertex before the given vertex index (first number is index 0) in the given GEOS Coordinate Sequence.
void translateVertex (QgsWkbPtr &wkbPtr, double dx, double dy, bool hasZValue)
 Translates a single vertex by dx and dy.
void transformVertex (QgsWkbPtr &wkbPtr, const QgsCoordinateTransform &ct, bool hasZValue)
 Transforms a single vertex by ct.
int splitLinearGeometry (GEOSGeometry *splitLine, QList< QgsGeometry * > &newGeometries)
 Splits line/multiline geometries.
int splitPolygonGeometry (GEOSGeometry *splitLine, QList< QgsGeometry * > &newGeometries)
 Splits polygon/multipolygon geometries.
int topologicalTestPointsSplit (const GEOSGeometry *splitLine, QList< QgsPoint > &testPoints) const
 Finds out the points that need to be tested for topological correctnes if this geometry will be split.
int numberOfGeometries (GEOSGeometry *g) const
 Returns number of single geometry in a geos geometry.
int mergeGeometriesMultiTypeSplit (QVector< GEOSGeometry * > &splitResult)
QgsPoint asPoint (QgsConstWkbPtr &wkbPtr, bool hasZValue) const
 return point from wkb
QgsPolyline asPolyline (QgsConstWkbPtr &wkbPtr, bool hasZValue) const
 return polyline from wkb
QgsPolygon asPolygon (QgsConstWkbPtr &wkbPtr, bool hasZValue) const
 return polygon from wkb
double leftOf (double x, double y, double &x1, double &y1, double &x2, double &y2)
 Returns < 0 if point(x/y) is left of the line x1,y1 -> x1,y2.

Static Private Member Functions

static GEOSGeometry * reshapeLine (const GEOSGeometry *origLine, const GEOSGeometry *reshapeLineGeos)
 Creates a new line from an original line and a reshape line.
static GEOSGeometry * reshapePolygon (const GEOSGeometry *polygon, const GEOSGeometry *reshapeLineGeos)
 Creates a new polygon replacing the part from the first to the second intersection with the reshape line.
static GEOSGeometry * nodeGeometries (const GEOSGeometry *splitLine, const GEOSGeometry *poly)
 Nodes together a split line and a (multi-) polygon geometry in a multilinestring.
static int lineContainedInLine (const GEOSGeometry *line1, const GEOSGeometry *line2)
 Tests if line1 is completely contained in line2.
static int pointContainedInLine (const GEOSGeometry *point, const GEOSGeometry *line)
 Tests if a point is on a line.
static bool geomInDegrees (const GEOSGeometry *geom)
 Tests if geom bounding rect is within -180 <= x <= 180, -90 <= y <= 90.
static bool geosRelOp (char(*op)(const GEOSGeometry *, const GEOSGeometry *), const QgsGeometry *a, const QgsGeometry *b)
static bool moveVertex (QgsWkbPtr &wkbPtr, const double &x, const double &y, int atVertex, bool hasZValue, int &pointIndex, bool isRing)
static bool deleteVertex (QgsConstWkbPtr &srcPtr, QgsWkbPtr &dstPtr, int atVertex, bool hasZValue, int &pointIndex, bool isRing, bool lastItem)
static bool insertVertex (QgsConstWkbPtr &srcPtr, QgsWkbPtr &dstPtr, int beforeVertex, const double &x, const double &y, bool hasZValue, int &pointIndex, bool isRing)

Private Attributes

unsigned char * mGeometry
 pointer to geometry in binary WKB format This is the class' native implementation
size_t mGeometrySize
 size of geometry
GEOSGeometry * mGeos
 cached GEOS version of this geometry
bool mDirtyWkb
 If the geometry has been set since the last conversion to WKB.
bool mDirtyGeos
 If the geometry has been set since the last conversion to GEOS.

Detailed Description

Definition at line 74 of file qgsgeometry.h.

Constructor & Destructor Documentation

QgsGeometry::QgsGeometry ( )

Constructor.

Definition at line 190 of file qgsgeometry.cpp.

Referenced by asGeometryCollection(), and combine().

QgsGeometry::QgsGeometry ( const QgsGeometry rhs)

copy constructor will prompt a deep copy of the object

Definition at line 199 of file qgsgeometry.cpp.

References mGeometry, mGeometrySize, and mGeos.

QgsGeometry::~QgsGeometry ( )

Destructor.

Definition at line 220 of file qgsgeometry.cpp.

References mGeometry, and mGeos.

Member Function Documentation

int QgsGeometry::addPart ( const QList< QgsPoint > &  points,
QGis::GeometryType  geomType = QGis::UnknownGeometry 
)

Adds a new island polygon to a multipolygon feature.

Returns
0 in case of success, 1 if not a multipolygon, 2 if ring is not a valid geometry, 3 if new polygon ring not disjoint with existing polygons of the feature

Definition at line 2433 of file qgsgeometry.cpp.

References createGeosLinearRing(), createGeosLineString(), createGeosPoint(), createGeosPolygon(), fromGeos(), QGis::Line, QgsMessageLog::logMessage(), QGis::Point, QGis::Polygon, QgsDebugMsg, tr, type(), QGis::UnknownGeometry, and GEOSException::what().

Referenced by QgsVectorLayerEditUtils::addPart(), addPart(), and QgsVectorLayerEditUtils::splitParts().

int QgsGeometry::addPart ( GEOSGeometry *  newPart)

Adds a new island polygon to a multipolygon feature.

Returns
0 in case of success, 1 if not a multipolygon, 2 if ring is not a valid geometry, 3 if new polygon ring not disjoint with existing polygons of the feature
Note
not available in python bindings

Definition at line 2540 of file qgsgeometry.cpp.

References convertToMultiType(), createGeosCollection(), exportWkbToGeos(), isMultipart(), QgsMessageLog::logMessage(), mDirtyGeos, mDirtyWkb, mGeos, QGis::Polygon, QgsDebugMsg, tr, type(), and GEOSException::what().

int QgsGeometry::addPart ( QgsGeometry newPart)

Adds a new island polygon to a multipolygon feature.

Returns
0 in case of success, 1 if not a multipolygon, 2 if ring is not a valid geometry, 3 if new polygon ring not disjoint with existing polygons of the feature
Note
available in python bindings as addPartGeometry (added in 2.2)

Definition at line 2531 of file qgsgeometry.cpp.

References addPart(), and asGeos().

int QgsGeometry::addRing ( const QList< QgsPoint > &  ring)

Adds a new ring to this geometry.

This makes only sense for polygon and multipolygons.

Returns
0 in case of success (ring added), 1 problem with geometry type, 2 ring not closed, 3 ring is not valid geometry, 4 ring not disjoint with existing rings, 5 no polygon found which contained the ring

Definition at line 2235 of file qgsgeometry.cpp.

References createGeosCollection(), createGeosLinearRing(), createGeosPolygon(), exportWkbToGeos(), QgsMessageLog::logMessage(), mDirtyGeos, mDirtyWkb, mGeos, QGis::Polygon, throwGEOSException(), tr, type(), GEOSException::what(), QGis::WKBMultiPolygon, QGis::WKBPolygon, and wkbType().

Referenced by QgsVectorLayerEditUtils::addRing().

void QgsGeometry::adjacentVertices ( int  atVertex,
int &  beforeVertex,
int &  afterVertex 
)

Returns the indexes of the vertices before and after the given vertex index.

This function takes into account the following factors:

  1. If the given vertex index is at the end of a linestring, the adjacent index will be -1 (for "no adjacent vertex")
  2. If the given vertex index is at the end of a linear ring (such as in a polygon), the adjacent index will take into account the first vertex is equal to the last vertex (and will skip equal vertex positions).

Definition at line 948 of file qgsgeometry.cpp.

References exportGeosToWkb(), index, mDirtyWkb, mGeometry, QgsDebugMsg, QGis::WKBLineString, QGis::WKBLineString25D, QGis::WKBMultiLineString, QGis::WKBMultiLineString25D, QGis::WKBMultiPoint, QGis::WKBMultiPoint25D, QGis::WKBMultiPolygon, QGis::WKBMultiPolygon25D, QGis::WKBPoint, QGis::WKBPolygon, QGis::WKBPolygon25D, and wkbType().

double QgsGeometry::area ( )

get area of geometry using GEOS

Note
added in 1.5

Definition at line 5434 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), mDirtyGeos, and mGeos.

Referenced by QgsPalLayerSettings::checkMinimumSizeMM(), and QgsZonalStatistics::statisticsFromPreciseIntersection().

QList< QgsGeometry * > QgsGeometry::asGeometryCollection ( ) const

return contents of the geometry as a list of geometries

Note
added in version 1.1

Definition at line 5672 of file qgsgeometry.cpp.

References exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, mGeos, QgsDebugMsg, and QgsGeometry().

Referenced by QgsGeometryAnalyzer::addEventLayerFeature(), and QgsGeometryAnalyzer::createOffsetGeometry().

const GEOSGeometry * QgsGeometry::asGeos ( ) const

Returns a geos geomtry.

QgsGeometry keeps ownership, don't delete the returned object!

Note
this method was added in version 1.1
not available in python bindings

Definition at line 614 of file qgsgeometry.cpp.

References exportWkbToGeos(), mDirtyGeos, and mGeos.

Referenced by addPart(), avoidIntersections(), isGeosEmpty(), isGeosValid(), QgsPalLabeling::registerDiagramFeature(), QgsPalLayerSettings::registerFeature(), QgsGeometryValidator::run(), and QgsZonalStatistics::statisticsFromMiddlePointTest().

QgsMultiPoint QgsGeometry::asMultiPoint ( ) const

return contents of the geometry as a multi point if wkbType is WKBMultiPoint, otherwise an empty list

Definition at line 5370 of file qgsgeometry.cpp.

References asPoint(), mGeometry, QGis::WKBMultiPoint, QGis::WKBMultiPoint25D, and wkbType().

Referenced by QgsRubberBand::addGeometry(), deletePart(), and QgsHighlight::paint().

QgsMultiPolygon QgsGeometry::asMultiPolygon ( ) const
QgsMultiPolyline QgsGeometry::asMultiPolyline ( ) const

return contents of the geometry as a multi linestring if wkbType is WKBMultiLineString, otherwise an empty list

Definition at line 5392 of file qgsgeometry.cpp.

References asPolyline(), mGeometry, QGis::WKBMultiLineString, QGis::WKBMultiLineString25D, and wkbType().

Referenced by QgsRubberBand::addGeometry(), QgsVectorLayerEditUtils::addTopologicalPoints(), QgsTransectSample::closestMultilineElement(), deletePart(), QgsHighlight::paint(), and QgsGeometryValidator::run().

QgsPoint QgsGeometry::asPoint ( ) const
QgsPoint QgsGeometry::asPoint ( QgsConstWkbPtr wkbPtr,
bool  hasZValue 
) const
private

return point from wkb

Definition at line 5269 of file qgsgeometry.cpp.

QgsPolygon QgsGeometry::asPolygon ( ) const
QgsPolygon QgsGeometry::asPolygon ( QgsConstWkbPtr wkbPtr,
bool  hasZValue 
) const
private

return polygon from wkb

Definition at line 5304 of file qgsgeometry.cpp.

QgsPolyline QgsGeometry::asPolyline ( ) const
QgsPolyline QgsGeometry::asPolyline ( QgsConstWkbPtr wkbPtr,
bool  hasZValue 
) const
private

return polyline from wkb

Definition at line 5281 of file qgsgeometry.cpp.

const unsigned char * QgsGeometry::asWkb ( ) const
int QgsGeometry::avoidIntersections ( QMap< QgsVectorLayer *, QSet< QgsFeatureId > >  ignoreFeatures = ( QMap<QgsVectorLayer*, QSet<QgsFeatureId> >() ))

Modifies geometry to avoid intersections with the layers specified in project properties.

Returns
0 in case of success, 1 if geometry is not of polygon type, 2 if avoid intersection would change the geometry type, 3 other error during intersection removal
Parameters
ignoreFeaturespossibility to give a list of features where intersections should be ignored (not available in python bindings)
Note
added in 1.5

Definition at line 5845 of file qgsgeometry.cpp.

References _makeUnion(), asGeos(), boundingBox(), QgsFeatureRequest::ExactIntersect, fromGeos(), QgsFeature::geometry(), QgsVectorLayer::getFeatures(), QgsFeature::id(), QgsMapLayerRegistry::instance(), QgsProject::instance(), QgsMessageLog::logMessage(), QgsMapLayerRegistry::mapLayer(), QgsFeatureIterator::nextFeature(), QGis::Polygon, QgsProject::readListEntry(), tr, type(), GEOSException::what(), and wkbType().

QgsRectangle QgsGeometry::boundingBox ( )
QgsGeometry * QgsGeometry::buffer ( double  distance,
int  segments 
)

Returns a buffer region around this geometry having the given width and with a specified number of segments used to approximate curves.

Definition at line 5495 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, and mGeos.

Referenced by QgsGeometryAnalyzer::bufferFeature(), QgsTransectSample::clipBufferLine(), fcnBuffer(), and QgsTransectSample::otherTransectWithinDistance().

QgsGeometry * QgsGeometry::centroid ( )

Returns the center of mass of a geometry.

Note
for line based geometries, the center point of the line is returned, and for point based geometries, the point itself is returned

Definition at line 5525 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, and mGeos.

Referenced by QgsGeometryAnalyzer::centroidFeature(), and fcnCentroid().

double QgsGeometry::closestSegmentWithContext ( const QgsPoint point,
QgsPoint minDistPoint,
int &  afterVertex,
double *  leftOf = 0,
double  epsilon = DEFAULT_SEGMENT_EPSILON 
)

Searches for the closest segment of geometry to the given point.

Parameters
pointSpecifies the point for search
minDistPointReceives the nearest point on the segment
afterVertexReceives index of the vertex after the closest segment. The vertex before the closest segment is always afterVertex - 1
leftOfOut: Returns if the point lies on the left of right side of the segment ( < 0 means left, > 0 means right )
epsilonepsilon for segment snapping (added in 1.8)
Returns
The squared cartesian distance is also returned in sqrDist, negative number on error

Definition at line 2009 of file qgsgeometry.cpp.

References exportGeosToWkb(), index, leftOf(), MathUtils::max(), mDirtyWkb, mGeometry, QgsDebugMsg, QgsPoint::sqrDistToSegment(), QgsPoint::toString(), QGis::WKBLineString, QGis::WKBLineString25D, QGis::WKBMultiLineString, QGis::WKBMultiLineString25D, QGis::WKBMultiPoint, QGis::WKBMultiPoint25D, QGis::WKBMultiPolygon, QGis::WKBMultiPolygon25D, QGis::WKBPoint, QGis::WKBPoint25D, QGis::WKBPolygon, QGis::WKBPolygon25D, wkbType(), QGis::WKBUnknown, QgsPoint::x(), and QgsPoint::y().

Referenced by QgsGeometryAnalyzer::createPointOffset(), QgsTransectSample::createSample(), and QgsVectorLayer::snapToGeometry().

QgsPoint QgsGeometry::closestVertex ( const QgsPoint point,
int &  atVertex,
int &  beforeVertex,
int &  afterVertex,
double &  sqrDist 
)

Returns the vertex closest to the given point, the corresponding vertex index, squared distance snap point / target point and the indices of the vertices before/after.

The vertices before/after are -1 if not present

Definition at line 705 of file qgsgeometry.cpp.

References exportGeosToWkb(), index, MathUtils::max(), mDirtyWkb, mGeometry, QgsDebugMsg, QgsPoint::set(), QgsPoint::sqrDist(), QGis::WKBLineString, QGis::WKBLineString25D, QGis::WKBMultiLineString, QGis::WKBMultiLineString25D, QGis::WKBMultiPoint, QGis::WKBMultiPoint25D, QGis::WKBMultiPolygon, QGis::WKBMultiPolygon25D, QGis::WKBPoint, QGis::WKBPoint25D, QGis::WKBPolygon, QGis::WKBPolygon25D, and wkbType().

Referenced by QgsVectorLayer::snapToGeometry().

double QgsGeometry::closestVertexWithContext ( const QgsPoint point,
int &  atVertex 
)

Searches for the closest vertex in this geometry to the given point.

Parameters
pointSpecifiest the point for search
atVertexReceives index of the closest vertex
Returns
The squared cartesian distance is also returned in sqrDist, negative number on error

Definition at line 1959 of file qgsgeometry.cpp.

References exportWkbToGeos(), QgsMessageLog::logMessage(), MathUtils::max(), mDirtyGeos, mGeos, QgsPoint::sqrDist(), tr, and GEOSException::what().

QgsGeometry * QgsGeometry::combine ( QgsGeometry geometry)

Returns a geometry representing all the points in this geometry and other (a union geometry operation).

Note
this operation is not called union since its a reserved word in C++.

Definition at line 5596 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), fromGeosGeom(), QGis::Line, mDirtyGeos, mGeos, QgsGeometry(), and type().

Referenced by QgsGeometryAnalyzer::bufferFeature(), QgsGeometryAnalyzer::convexFeature(), QgsGeometryAnalyzer::dissolveFeature(), and fcnCombine().

bool QgsGeometry::contains ( const QgsPoint p) const

Test for containment of a point (uses GEOS)

Definition at line 3352 of file qgsgeometry.cpp.

References createGeosPoint(), exportWkbToGeos(), QgsMessageLog::logMessage(), mGeos, QgsDebugMsg, tr, and GEOSException::what().

Referenced by fcnContains(), and QgsPalLayerSettings::registerFeature().

bool QgsGeometry::contains ( const QgsGeometry geometry) const

Test for if geometry is contained in another (uses GEOS)

Note
added in 1.5

Definition at line 3413 of file qgsgeometry.cpp.

References geosRelOp().

bool QgsGeometry::convertToMultiType ( )
QgsGeometry * QgsGeometry::convexHull ( )

Returns the smallest convex polygon that contains all the points in the geometry.

Definition at line 5540 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, and mGeos.

Referenced by QgsGeometryAnalyzer::convexFeature(), QgsGeometryAnalyzer::convexHull(), and fcnConvexHull().

bool QgsGeometry::crosses ( const QgsGeometry geometry) const

Test for if geometry crosses another (uses GEOS)

Note
added in 1.5

Definition at line 3443 of file qgsgeometry.cpp.

References geosRelOp().

Referenced by fcnCrosses().

bool QgsGeometry::deletePart ( int  partNum)
bool QgsGeometry::deleteRing ( int  ringNum,
int  partNum = 0 
)

delete a ring in polygon or multipolygon.

Ring 0 is outer ring and can't be deleted.

Returns
true on success
Note
added in version 1.2

Definition at line 5707 of file qgsgeometry.cpp.

References asMultiPolygon(), asPolygon(), fromMultiPolygon(), fromPolygon(), QGis::WKBMultiPolygon, QGis::WKBMultiPolygon25D, QGis::WKBPolygon, QGis::WKBPolygon25D, and wkbType().

bool QgsGeometry::deleteVertex ( int  atVertex)

Deletes the vertex at the given position number and item (first number is index 0) Returns false if atVertex does not correspond to a valid vertex on this geometry (including if this geometry is a Point), or if the number of remaining verticies in the linestring would be less than two.

It is up to the caller to distinguish between these error conditions. (Or maybe we add another method to this object to help make the distinction?)

Definition at line 1430 of file qgsgeometry.cpp.

References exportGeosToWkb(), QGis::flatType(), mDirtyGeos, mDirtyWkb, mGeometry, mGeometrySize, QgsDebugMsg, QGis::wkbDimensions(), QGis::WKBLineString, QGis::WKBLineString25D, QGis::WKBMultiLineString, QGis::WKBMultiLineString25D, QGis::WKBMultiPoint, QGis::WKBMultiPoint25D, QGis::WKBMultiPolygon, QGis::WKBMultiPolygon25D, QGis::WKBNoGeometry, QGis::WKBPoint, QGis::WKBPoint25D, QGis::WKBPolygon, QGis::WKBPolygon25D, wkbType(), and QGis::WKBUnknown.

Referenced by QgsVectorLayerEditUtils::deleteVertex().

bool QgsGeometry::deleteVertex ( QgsConstWkbPtr srcPtr,
QgsWkbPtr dstPtr,
int  atVertex,
bool  hasZValue,
int &  pointIndex,
bool  isRing,
bool  lastItem 
)
inlinestaticprivate

Definition at line 1365 of file qgsgeometry.cpp.

References QgsDebugMsg.

QgsGeometry * QgsGeometry::difference ( QgsGeometry geometry)

Returns a geometry representing the points making up this geometry that do not make up other.

Definition at line 5630 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, and mGeos.

Referenced by fcnDifference().

bool QgsGeometry::disjoint ( const QgsGeometry geometry) const

Test for if geometry is disjoint of another (uses GEOS)

Note
added in 1.5

Definition at line 3418 of file qgsgeometry.cpp.

References geosRelOp().

Referenced by fcnDisjoint().

double QgsGeometry::distance ( QgsGeometry geom)
bool QgsGeometry::equals ( const QgsGeometry geometry) const

Test for if geometry equals another (uses GEOS)

Note
added in 1.5

Definition at line 3423 of file qgsgeometry.cpp.

References geosRelOp().

bool QgsGeometry::exportGeosToWkb ( ) const
private
QString QgsGeometry::exportToGeoJSON ( ) const
QString QgsGeometry::exportToWkt ( ) const
bool QgsGeometry::exportWkbToGeos ( ) const
private
void QgsGeometry::fromGeos ( GEOSGeometry *  geos)

Set the geometry, feeding in a geometry in GEOS format.

This class will take ownership of the buffer.

Note
not available in python bindings

Definition at line 683 of file qgsgeometry.cpp.

References mDirtyGeos, mDirtyWkb, mGeometry, and mGeos.

Referenced by addPart(), avoidIntersections(), QgsGeometryAnalyzer::createOffsetGeometry(), and fromGeosGeom().

QgsGeometry * QgsGeometry::fromMultiPoint ( const QgsMultiPoint multipoint)
static
QgsGeometry * QgsGeometry::fromMultiPolygon ( const QgsMultiPolygon multipoly)
static

construct geometry from a multipolygon

Definition at line 504 of file qgsgeometry.cpp.

References createGeosCollection(), createGeosPolygon(), fromGeosGeom(), QgsMessageLog::logMessage(), tr, and GEOSException::what().

Referenced by deletePart(), and deleteRing().

QgsGeometry * QgsGeometry::fromMultiPolyline ( const QgsMultiPolyline multiline)
static
QgsGeometry * QgsGeometry::fromPoint ( const QgsPoint point)
static

construct geometry from a point

Definition at line 445 of file qgsgeometry.cpp.

References createGeosPoint(), and fromGeosGeom().

Referenced by QgsPointSample::addSamplePoints(), and QgsTransectSample::closestMultilineElement().

QgsGeometry * QgsGeometry::fromPolygon ( const QgsPolygon polygon)
static

construct geometry from a polygon

Definition at line 455 of file qgsgeometry.cpp.

References createGeosPolygon(), and fromGeosGeom().

Referenced by QgsRubberBand::asGeometry(), QgsTransectSample::clipBufferLine(), deleteRing(), and fromRect().

QgsGeometry * QgsGeometry::fromPolyline ( const QgsPolyline polyline)
static
QgsGeometry * QgsGeometry::fromRect ( const QgsRectangle rect)
static
void QgsGeometry::fromWkb ( unsigned char *  wkb,
size_t  length 
)
QgsGeometry * QgsGeometry::fromWkt ( QString  wkt)
static
bool QgsGeometry::geomInDegrees ( const GEOSGeometry *  geom)
staticprivate

Tests if geom bounding rect is within -180 <= x <= 180, -90 <= y <= 90.

Other methods may use more accurate tolerances if this is true

Definition at line 5151 of file qgsgeometry.cpp.

Referenced by lineContainedInLine(), and pointContainedInLine().

bool QgsGeometry::geosRelOp ( char(*)(const GEOSGeometry *, const GEOSGeometry *)  op,
const QgsGeometry a,
const QgsGeometry b 
)
staticprivate
bool QgsGeometry::insertVertex ( double  x,
double  y,
int  beforeVertex 
)

Insert a new vertex before the given vertex index, ring and item (first number is index 0) If the requested vertex number (beforeVertex.back()) is greater than the last actual vertex on the requested ring and item, it is assumed that the vertex is to be appended instead of inserted.

Returns false if atVertex does not correspond to a valid vertex on this geometry (including if this geometry is a Point). It is up to the caller to distinguish between these error conditions. (Or maybe we add another method to this object to help make the distinction?)

Definition at line 1625 of file qgsgeometry.cpp.

References exportGeosToWkb(), QGis::flatType(), mDirtyGeos, mDirtyWkb, mGeometry, mGeometrySize, QgsDebugMsg, QGis::wkbDimensions(), QGis::WKBLineString, QGis::WKBLineString25D, QGis::WKBMultiLineString, QGis::WKBMultiLineString25D, QGis::WKBMultiPoint, QGis::WKBMultiPoint25D, QGis::WKBMultiPolygon, QGis::WKBMultiPolygon25D, QGis::WKBNoGeometry, QGis::WKBPoint, QGis::WKBPoint25D, QGis::WKBPolygon, QGis::WKBPolygon25D, wkbType(), and QGis::WKBUnknown.

Referenced by QgsVectorLayerEditUtils::insertVertex().

bool QgsGeometry::insertVertex ( double  x,
double  y,
int  beforeVertex,
const GEOSCoordSequence *  old_sequence,
GEOSCoordSequence **  new_sequence 
)
private

Insert a new vertex before the given vertex index (first number is index 0) in the given GEOS Coordinate Sequence.

If the requested vertex number is greater than the last actual vertex, it is assumed that the vertex is to be appended instead of inserted.

Parameters
xx coordinate
yy coordinate
beforeVertexinsert before vertex with this index
old_sequenceThe sequence to update (The caller remains the owner).
new_sequenceThe updated sequence (The caller becomes the owner if the function returns true). Returns false if beforeVertex does not correspond to a valid vertex number on the Coordinate Sequence.

Definition at line 1141 of file qgsgeometry.cpp.

bool QgsGeometry::insertVertex ( QgsConstWkbPtr srcPtr,
QgsWkbPtr dstPtr,
int  beforeVertex,
const double &  x,
const double &  y,
bool  hasZValue,
int &  pointIndex,
bool  isRing 
)
inlinestaticprivate

Definition at line 1577 of file qgsgeometry.cpp.

QgsGeometry * QgsGeometry::interpolate ( double  distance)
QgsGeometry * QgsGeometry::intersection ( QgsGeometry geometry)
bool QgsGeometry::intersects ( const QgsRectangle r) const

Test for intersection with a rectangle (uses GEOS)

Definition at line 3322 of file qgsgeometry.cpp.

References fromRect().

Referenced by QgsFeatureRequest::acceptFeature(), QgsTransectSample::clipBufferLine(), fcnBbox(), fcnIntersects(), and QgsOverlayAnalyzer::intersectFeature().

bool QgsGeometry::intersects ( const QgsGeometry geometry) const

Test for intersection with a geometry (uses GEOS)

Definition at line 3330 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), mGeos, and QgsDebugMsg.

bool QgsGeometry::isGeosEmpty ( )

check if geometry is empty using GEOS

Note
added in 1.5

Definition at line 5953 of file qgsgeometry.cpp.

References asGeos(), QgsMessageLog::logMessage(), tr, and GEOSException::what().

bool QgsGeometry::isGeosEqual ( QgsGeometry g)

compare geometries using GEOS

Note
added in 1.5

Definition at line 5948 of file qgsgeometry.cpp.

References geosRelOp().

Referenced by QgsVectorLayer::updateFeature().

bool QgsGeometry::isGeosValid ( )

check validity using GEOS

Note
added in 1.5

Definition at line 5930 of file qgsgeometry.cpp.

References asGeos(), QgsMessageLog::logMessage(), tr, and GEOSException::what().

bool QgsGeometry::isMultipart ( )
double QgsGeometry::leftOf ( double  x,
double  y,
double &  x1,
double &  y1,
double &  x2,
double &  y2 
)
private

Returns < 0 if point(x/y) is left of the line x1,y1 -> x1,y2.

Definition at line 5971 of file qgsgeometry.cpp.

Referenced by closestSegmentWithContext().

double QgsGeometry::length ( )

get length of geometry using GEOS

Note
added in 1.5

Definition at line 5454 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), mDirtyGeos, and mGeos.

Referenced by QgsPalLayerSettings::checkMinimumSizeMM(), QgsTransectSample::createSample(), and fromWkb().

int QgsGeometry::lineContainedInLine ( const GEOSGeometry *  line1,
const GEOSGeometry *  line2 
)
staticprivate

Tests if line1 is completely contained in line2.

This method works with a very small buffer around line2 and therefore is less prone to numerical errors as the corresponding geos method

Definition at line 5096 of file qgsgeometry.cpp.

References DEFAULT_QUADRANT_SEGMENTS, and geomInDegrees().

Referenced by reshapeLine().

int QgsGeometry::makeDifference ( QgsGeometry other)

Changes this geometry such that it does not intersect the other geometry.

Parameters
othergeometry that should not be intersect
Returns
0 in case of success

Definition at line 3031 of file qgsgeometry.cpp.

References CATCH_GEOS, convertToMultiType(), exportWkbToGeos(), isMultipart(), mDirtyGeos, mDirtyWkb, and mGeos.

Referenced by QgsVectorLayer::removePolygonIntersections().

int QgsGeometry::mergeGeometriesMultiTypeSplit ( QVector< GEOSGeometry * > &  splitResult)
private
bool QgsGeometry::moveVertex ( double  x,
double  y,
int  atVertex 
)

Moves the vertex at the given position number and item (first number is index 0) to the given coordinates.

Returns false if atVertex does not correspond to a valid vertex on this geometry

Definition at line 1228 of file qgsgeometry.cpp.

References exportGeosToWkb(), mDirtyGeos, mDirtyWkb, mGeometry, QgsDebugMsg, QGis::WKBLineString, QGis::WKBLineString25D, QGis::WKBMultiLineString, QGis::WKBMultiLineString25D, QGis::WKBMultiPoint, QGis::WKBMultiPoint25D, QGis::WKBMultiPolygon, QGis::WKBMultiPolygon25D, QGis::WKBPoint, QGis::WKBPoint25D, QGis::WKBPolygon, QGis::WKBPolygon25D, and wkbType().

Referenced by QgsVectorLayerEditUtils::moveVertex().

bool QgsGeometry::moveVertex ( QgsWkbPtr wkbPtr,
const double &  x,
const double &  y,
int  atVertex,
bool  hasZValue,
int &  pointIndex,
bool  isRing 
)
inlinestaticprivate

Definition at line 1193 of file qgsgeometry.cpp.

GEOSGeometry * QgsGeometry::nodeGeometries ( const GEOSGeometry *  splitLine,
const GEOSGeometry *  poly 
)
staticprivate

Nodes together a split line and a (multi-) polygon geometry in a multilinestring.

Returns
the noded multiline geometry or 0 in case of error. The calling function takes ownership of the node geometry

Definition at line 5077 of file qgsgeometry.cpp.

Referenced by reshapeLine(), and splitPolygonGeometry().

int QgsGeometry::numberOfGeometries ( GEOSGeometry *  g) const
private

Returns number of single geometry in a geos geometry.

Is save for geos 2 and 3

Definition at line 5186 of file qgsgeometry.cpp.

Referenced by splitPolygonGeometry().

QgsGeometry & QgsGeometry::operator= ( QgsGeometry const &  rhs)

assignments will prompt a deep copy of the object

Note
not available in python bindings

Definition at line 545 of file qgsgeometry.cpp.

References mDirtyGeos, mDirtyWkb, mGeometry, mGeometrySize, and mGeos.

bool QgsGeometry::overlaps ( const QgsGeometry geometry) const

Test for if geometry overlaps another (uses GEOS)

Note
added in 1.5

Definition at line 3433 of file qgsgeometry.cpp.

References geosRelOp().

Referenced by fcnOverlaps().

int QgsGeometry::pointContainedInLine ( const GEOSGeometry *  point,
const GEOSGeometry *  line 
)
staticprivate

Tests if a point is on a line.

This method works with a very small buffer and is thus less prone to numerical problems as the direct geos functions.

Parameters
pointthe point to test
lineline to test
Returns
0 not contained, 1 if contained, <0 in case of error

Definition at line 5130 of file qgsgeometry.cpp.

References geomInDegrees().

Referenced by reshapeLine().

int QgsGeometry::reshapeGeometry ( const QList< QgsPoint > &  reshapeWithLine)

Replaces a part of this geometry with another line.

Returns
0 in case of success
Note
: this function was added in version 1.3

Definition at line 2924 of file qgsgeometry.cpp.

References createGeosLineString(), exportWkbToGeos(), QGis::Line, mDirtyGeos, mDirtyWkb, mGeos, QGis::Point, reshapeLine(), reshapePolygon(), and type().

GEOSGeometry * QgsGeometry::reshapeLine ( const GEOSGeometry *  origLine,
const GEOSGeometry *  reshapeLineGeos 
)
staticprivate

Creates a new line from an original line and a reshape line.

The part of the input line from the first to the last intersection with the reshape line will be replaced. The calling function takes ownership of the result.

Parameters
origLinethe original line
reshapeLineGeosthe reshape line
Returns
the reshaped line or 0 in case of error

Definition at line 4809 of file qgsgeometry.cpp.

References createGeosPoint(), lineContainedInLine(), QgsMessageLog::logMessage(), nodeGeometries(), pointContainedInLine(), tr, and GEOSException::what().

Referenced by reshapeGeometry(), and reshapePolygon().

GEOSGeometry * QgsGeometry::reshapePolygon ( const GEOSGeometry *  polygon,
const GEOSGeometry *  reshapeLineGeos 
)
staticprivate

Creates a new polygon replacing the part from the first to the second intersection with the reshape line.

As a polygon ring is always closed, the method keeps the longer part of the existing boundary

Parameters
polygongeometry to reshape
reshapeLineGeosthe reshape line
Returns
the reshaped polygon or 0 in case of error

Definition at line 4696 of file qgsgeometry.cpp.

References QgsMessageLog::logMessage(), reshapeLine(), tr, and GEOSException::what().

Referenced by reshapeGeometry().

QgsGeometry * QgsGeometry::simplify ( double  tolerance)

Returns a simplified version of this geometry using a specified tolerance value.

Definition at line 5510 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, and mGeos.

Referenced by QgsTopologyPreservingSimplifier::simplify(), QgsGeometryAnalyzer::simplifyFeature(), and QgsTopologyPreservingSimplifier::simplifyGeometry().

int QgsGeometry::splitGeometry ( const QList< QgsPoint > &  splitLine,
QList< QgsGeometry * > &  newGeometries,
bool  topological,
QList< QgsPoint > &  topologyTestPoints 
)

Splits this geometry according to a given line.

Note that the geometry is only split once. If there are several intersections between geometry and splitLine, only the first one is considered.

Parameters
splitLinethe line that splits the geometry
[out]newGeometrieslist of new geometries that have been created with the split
topologicaltrue if topological editing is enabled
[out]topologyTestPointspoints that need to be tested for topological completeness in the dataset
Returns
0 in case of success, 1 if geometry has not been split, error else

Definition at line 2857 of file qgsgeometry.cpp.

References CATCH_GEOS, createGeosLineString(), exportGeosToWkb(), exportWkbToGeos(), QGis::Line, mDirtyGeos, mDirtyWkb, mGeos, QGis::Point, QGis::Polygon, splitLinearGeometry(), splitPolygonGeometry(), topologicalTestPointsSplit(), and type().

Referenced by QgsVectorLayerEditUtils::splitFeatures(), and QgsVectorLayerEditUtils::splitParts().

int QgsGeometry::splitLinearGeometry ( GEOSGeometry *  splitLine,
QList< QgsGeometry * > &  newGeometries 
)
private

Splits line/multiline geometries.

Parameters
splitLinethe line that splits the feature
newGeometriesnew geometries if splitting was successful
Returns
0 in case of success, 1 if geometry has not been split, error else

Definition at line 4534 of file qgsgeometry.cpp.

References exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, mDirtyWkb, mergeGeometriesMultiTypeSplit(), and mGeos.

Referenced by splitGeometry().

int QgsGeometry::splitPolygonGeometry ( GEOSGeometry *  splitLine,
QList< QgsGeometry * > &  newGeometries 
)
private

Splits polygon/multipolygon geometries.

Returns
0 in case of success, 1 if geometry has not been split, error else

Definition at line 4588 of file qgsgeometry.cpp.

References exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, mDirtyWkb, mergeGeometriesMultiTypeSplit(), mGeos, nodeGeometries(), numberOfGeometries(), and QgsDebugMsg.

Referenced by splitGeometry().

double QgsGeometry::sqrDistToVertexAt ( QgsPoint point,
int  atVertex 
)

Returns the squared cartesian distance between the given point to the given vertex index (vertex at the given position number, ring and item (first number is index 0))

Definition at line 1943 of file qgsgeometry.cpp.

References MathUtils::max(), QgsDebugMsg, QgsPoint::sqrDist(), QgsPoint::toString(), and vertexAt().

QgsGeometry * QgsGeometry::symDifference ( QgsGeometry geometry)

Returns a Geometry representing the points making up this Geometry that do not make up other.

Definition at line 5651 of file qgsgeometry.cpp.

References CATCH_GEOS, exportWkbToGeos(), fromGeosGeom(), mDirtyGeos, and mGeos.

Referenced by fcnSymDifference().

int QgsGeometry::topologicalTestPointsSplit ( const GEOSGeometry *  splitLine,
QList< QgsPoint > &  testPoints 
) const
private

Finds out the points that need to be tested for topological correctnes if this geometry will be split.

Returns
0 in case of success

Definition at line 5029 of file qgsgeometry.cpp.

References mGeos.

Referenced by splitGeometry().

bool QgsGeometry::touches ( const QgsGeometry geometry) const

Test for if geometry touch another (uses GEOS)

Note
added in 1.5

Definition at line 3428 of file qgsgeometry.cpp.

References geosRelOp().

Referenced by fcnTouches().

int QgsGeometry::transform ( const QgsCoordinateTransform ct)
void QgsGeometry::transformVertex ( QgsWkbPtr wkbPtr,
const QgsCoordinateTransform ct,
bool  hasZValue 
)
private

Transforms a single vertex by ct.

Parameters
wkbPtrpointer to current position in wkb. Is increased automatically by the function
ctthe QgsCoordinateTransform
hasZValue25D type?

Definition at line 4517 of file qgsgeometry.cpp.

References QgsCoordinateTransform::transformInPlace().

Referenced by transform().

int QgsGeometry::translate ( double  dx,
double  dy 
)
void QgsGeometry::translateVertex ( QgsWkbPtr wkbPtr,
double  dx,
double  dy,
bool  hasZValue 
)
private

Translates a single vertex by dx and dy.

Parameters
wkbPtrpointer to current position in wkb array. Is increased automatically by the function
dxtranslation of x coordinate
dytranslation of y coordinate
hasZValue25D type?

Definition at line 4497 of file qgsgeometry.cpp.

Referenced by translate().

QGis::GeometryType QgsGeometry::type ( )
void QgsGeometry::validateGeometry ( QList< Error > &  errors)

Validate geometry and produce a list of geometry errors.

Note
added in 1.5
python binding added in 1.6

Definition at line 5925 of file qgsgeometry.cpp.

QgsPoint QgsGeometry::vertexAt ( int  atVertex)
bool QgsGeometry::within ( const QgsGeometry geometry) const

Test for if geometry is within another (uses GEOS)

Note
added in 1.5

Definition at line 3438 of file qgsgeometry.cpp.

References geosRelOp().

Referenced by QgsPointSample::addSamplePoints(), and fcnWithin().

size_t QgsGeometry::wkbSize ( ) const
QGis::WkbType QgsGeometry::wkbType ( ) const

Member Data Documentation

bool QgsGeometry::mDirtyGeos
mutableprivate
bool QgsGeometry::mDirtyWkb
mutableprivate
unsigned char* QgsGeometry::mGeometry
mutableprivate
size_t QgsGeometry::mGeometrySize
mutableprivate

size of geometry

Definition at line 491 of file qgsgeometry.h.

Referenced by convertToMultiType(), deleteVertex(), exportGeosToWkb(), fromWkb(), insertVertex(), operator=(), QgsGeometry(), and wkbSize().

GEOSGeometry* QgsGeometry::mGeos
mutableprivate

The documentation for this class was generated from the following files: