Routines

Routines

Name Type Language Deterministic Return Type Security Restriction Comments
path FUNCTION C true path INVOKER
updategeometrysrid FUNCTION PLPGSQL false text INVOKER

args: catalog_name, schema_name, table_name, column_name, srid - Updates the SRID of all features in a geometry column, and the table metadata.

st_collectionhomogenize FUNCTION C true geometry INVOKER

args: collection - Returns the simplest representation of a geometry collection.

st_linesubstring FUNCTION C true geography INVOKER
st_asflatgeobuf AGGREGATE INTERNAL true bytea INVOKER
geometry_gist_distance_nd FUNCTION C false double precision INVOKER
geometry_gist_consistent_2d FUNCTION C false boolean INVOKER
st_straightskeleton FUNCTION C true geometry INVOKER

args: geom - Compute a straight skeleton from a geometry

st_memcollect AGGREGATE INTERNAL true geometry INVOKER
st_removerepeatedpoints FUNCTION C true geometry INVOKER

args: geom, tolerance - Returns a version of a geometry with duplicate points removed.

pgis_geometry_coverageunion_finalfn FUNCTION C false geometry INVOKER
st_forcecollection FUNCTION C true geometry INVOKER

args: geomA - Convert the geometry into a GEOMETRYCOLLECTION.

st_addpoint FUNCTION C true geometry INVOKER

args: linestring, point, position = -1 - Add a point to a LineString.

st_clusterkmeans WINDOW C false integer INVOKER

args: geom, number_of_clusters, max_radius - Window function that returns a cluster id for each input geometry using the K-means algorithm.

geometry_gist_penalty_2d FUNCTION C false internal INVOKER
geomfromewkt FUNCTION C true geometry INVOKER
debug_standardize_address FUNCTION C true text INVOKER
_postgis_stats FUNCTION C false text INVOKER
geography_typmod_out FUNCTION C true cstring INVOKER
st_maximuminscribedcircle FUNCTION C true record INVOKER

args: geom - Computes the largest circle contained within a geometry.

postgis_version FUNCTION C true text INVOKER

Returns PostGIS version number and compile-time options.

_st_dfullywithin FUNCTION C true boolean INVOKER
st_issimple FUNCTION C true boolean INVOKER

args: geomA - Tests if a geometry has no points of self-intersection or self-tangency.

standardize_address FUNCTION C true stdaddr INVOKER
st_asgml FUNCTION C true text INVOKER
st_project FUNCTION C true geography INVOKER

args: g1, g2, distance - Returns a point projected from a start point by a distance and bearing (azimuth).

st_lineinterpolatepoints FUNCTION C true geography INVOKER
gettransactionid FUNCTION C false xid INVOKER
st_linefromencodedpolyline FUNCTION C true geometry INVOKER
st_linefromtext FUNCTION SQL true geometry INVOKER
st_wkbtosql FUNCTION C true geometry INVOKER
st_numgeometries FUNCTION C true integer INVOKER

args: geom - Returns the number of elements in a geometry collection.

pgis_geometry_union_parallel_deserialfn FUNCTION C true internal INVOKER
st_geomcollfromwkb FUNCTION SQL true geometry INVOKER
geometry_gist_union_nd FUNCTION C false internal INVOKER
st_geometryn FUNCTION C true geometry INVOKER

args: geomA, n - Return an element of a geometry collection.

st_symdifference FUNCTION C true geometry INVOKER

args: geomA, geomB, gridSize = -1 - Computes a geometry representing the portions of geometries A and B that do not intersect.

st_combinebbox FUNCTION C true box3d INVOKER
st_tileenvelope FUNCTION C true geometry INVOKER

args: tileZoom, tileX, tileY, bounds=SRID=3857;LINESTRING(-20037508.342789 -20037508.342789,20037508.342789 20037508.342789), margin=0.0 - Creates a rectangular Polygon in Web Mercator (SRID:3857) using the XYZ tile system.

st_forcerhr FUNCTION C true geometry INVOKER

args: g - Force the orientation of the vertices in a polygon to follow the Right-Hand-Rule.

st_chaikinsmoothing FUNCTION C true geometry INVOKER

args: geom, nIterations = 1, preserveEndPoints = false - Returns a smoothed version of a geometry, using the Chaikin algorithm

st_geomcollfromtext FUNCTION SQL true geometry INVOKER
levenshtein FUNCTION C true integer INVOKER
st_makeenvelope FUNCTION C true geometry INVOKER

args: xmin, ymin, xmax, ymax, srid=unknown - Creates a rectangular Polygon from minimum and maximum coordinates.

postgis_srs_all FUNCTION C true SETOF record INVOKER

Return metadata records for every spatial reference system in the underlying Proj database.

st_minimumboundingcircle FUNCTION C true geometry INVOKER

args: geomA, num_segs_per_qt_circ=48 - Returns the smallest circle polygon that contains a geometry.

postgis_srs_codes FUNCTION C true SETOF text INVOKER

args: auth_name - Return the list of SRS codes associated with the given authority.

geometry_contained_3d FUNCTION C true boolean INVOKER
jsonb FUNCTION C true jsonb INVOKER
st_pointfromgeohash FUNCTION C true geometry INVOKER
geom3d_brin_inclusion_add_value FUNCTION C false boolean INVOKER
st_isempty FUNCTION C true boolean INVOKER

args: geomA - Tests if a geometry is empty.

st_inversetransformpipeline FUNCTION SQL true geometry INVOKER

args: geom, pipeline, to_srid - Return a new geometry with coordinates transformed to a different spatial reference system using the inverse of a defined coordinate transformation pipeline.

is_contained_2d FUNCTION C true boolean INVOKER
get_proj4_from_srid FUNCTION PLPGSQL true text INVOKER
st_hexagon FUNCTION C true geometry INVOKER

args: size, cell_i, cell_j, origin - Returns a single hexagon, using the provided edge size and cell coordinate within the hexagon grid space.

dmetaphone FUNCTION C true text INVOKER
postgis_typmod_type FUNCTION C true text INVOKER
geography_gist_union FUNCTION C false internal INVOKER
st_extrude FUNCTION C true geometry INVOKER

args: geom, x, y, z - Extrude a surface to a related volume

geom2d_brin_inclusion_add_value FUNCTION C false boolean INVOKER
st_mpolyfromwkb FUNCTION SQL true geometry INVOKER
_st_asgml FUNCTION C true text INVOKER
st_boundary FUNCTION C true geometry INVOKER

args: geomA - Returns the boundary of a geometry.

st_geographyfromtext FUNCTION C true geography INVOKER
geometry_typmod_in FUNCTION C true integer INVOKER
st_makepoint FUNCTION C true geometry INVOKER

args: x, y, z, m - Creates a 2D, 3DZ or 4D Point.

st_equals FUNCTION C true boolean INVOKER
st_3dintersects FUNCTION C true boolean INVOKER
st_constraineddelaunaytriangles FUNCTION C true geometry INVOKER

args: g1 - Return a constrained Delaunay triangulation around the given input geometry.

_st_3ddfullywithin FUNCTION C true boolean INVOKER
st_3dintersection FUNCTION C true geometry INVOKER

args: geom1, geom2 - Perform 3D intersection

st_scroll FUNCTION C true geometry INVOKER

args: linestring, point - Change start point of a closed LineString.

st_asgeojson FUNCTION C true text INVOKER
st_geometricmedian FUNCTION C true geometry INVOKER

args: geom, tolerance = NULL, max_iter = 10000, fail_if_not_converged = false - Returns the geometric median of a MultiPoint.

postgis_extensions_upgrade FUNCTION PLPGSQL false text INVOKER

args: target_version=null - Packages and upgrades PostGIS extensions (e.g. postgis_raster,postgis_topology, postgis_sfcgal) to given or latest version.

geometry_gist_picksplit_nd FUNCTION C false internal INVOKER
geography_gist_decompress FUNCTION C false internal INVOKER
st_asx3d FUNCTION SQL true text INVOKER
st_triangulatepolygon FUNCTION C true geometry INVOKER

args: geom - Computes the constrained Delaunay triangulation of polygons

_st_distanceuncached FUNCTION C true double precision INVOKER
_st_containsproperly FUNCTION C true boolean INVOKER
geometry_recv FUNCTION C true geometry INVOKER
_st_dwithinuncached FUNCTION C true boolean INVOKER
pgis_geometry_clusterwithin_finalfn FUNCTION C false ARRAY INVOKER
st_3dconvexhull FUNCTION C true geometry INVOKER

args: geom1 - Computes the 3D convex hull of a geometry.

geometry_gist_union_2d FUNCTION C false internal INVOKER
geometry_gist_sortsupport_2d FUNCTION C false void INVOKER
st_isplanar FUNCTION C true boolean INVOKER

args: geom - Check if a surface is or not planar

postgis_transform_pipeline_geometry FUNCTION C true geometry INVOKER
postgis_geos_noop FUNCTION C true geometry INVOKER
st_startpoint FUNCTION C true geometry INVOKER

args: geomA - Returns the first point of a LineString.

st_shiftlongitude FUNCTION C true geometry INVOKER

args: geom - Shifts the longitude coordinates of a geometry between -180..180 and 0..360.

st_letters FUNCTION PLPGSQL true geometry INVOKER

args: letters, font - Returns the input letters rendered as geometry with a default start position at the origin and default text height of 100.

geometry_cmp FUNCTION C true integer INVOKER
st_coverageunion FUNCTION C true geometry INVOKER
geometry_overabove FUNCTION C true boolean INVOKER
pgis_asmvt_deserialfn FUNCTION C true internal INVOKER
postgis_dropbbox FUNCTION C true geometry INVOKER

args: geomA - Drop the bounding box cache from the geometry.

st_shortestline FUNCTION C true geography INVOKER
postgis_wagyu_version FUNCTION C true text INVOKER

Returns the version number of the internal Wagyu library.

contains_2d FUNCTION C true boolean INVOKER
geomfromewkb FUNCTION C true geometry INVOKER
json FUNCTION C true json INVOKER
st_astwkb FUNCTION C true bytea INVOKER
st_geogfromwkb FUNCTION C true geography INVOKER
st_numinteriorrings FUNCTION C true integer INVOKER

args: a_polygon - Returns the number of interior rings (holes) of a Polygon.

st_polygon FUNCTION SQL true geometry INVOKER

args: lineString, srid - Creates a Polygon from a LineString with a specified SRID.

gserialized_gist_sel_2d FUNCTION C false double precision INVOKER
geography_send FUNCTION C true bytea INVOKER
postgis_transform_geometry FUNCTION C true geometry INVOKER
addgeometrycolumn FUNCTION PLPGSQL false text INVOKER

args: catalog_name, schema_name, table_name, column_name, srid, type, dimension, use_typmod=true - Adds a geometry column to an existing table.

geography FUNCTION C true geography INVOKER
pgis_geometry_makeline_finalfn FUNCTION C false geometry INVOKER
geometry FUNCTION C true geometry INVOKER
st_setsrid FUNCTION C true geography INVOKER
st_clusterdbscan WINDOW C true integer INVOKER

args: geom, eps, minpoints - Window function that returns a cluster id for each input geometry using the DBSCAN algorithm.

st_unaryunion FUNCTION C true geometry INVOKER

args: geom, gridSize = -1 - Computes the union of the components of a single geometry.

st_geomfromkml FUNCTION C true geometry INVOKER
st_linemerge FUNCTION C true geometry INVOKER

args: amultilinestring, directed - Return the lines formed by sewing together a MultiLineString.

st_swapordinates FUNCTION C true geometry INVOKER

args: geom, ords - Returns a version of the given geometry with given ordinate values swapped.

geography_typmod_in FUNCTION C true integer INVOKER
geometry_typmod_out FUNCTION C true cstring INVOKER
st_lineextend FUNCTION C true geometry INVOKER

args: line, distance_forward, distance_backward=0.0 - Returns a line with the last and first segments extended the specified distance(s).

pgis_asflatgeobuf_transfn FUNCTION C true internal INVOKER
st_overlaps FUNCTION C true boolean INVOKER
st_containsproperly FUNCTION C true boolean INVOKER
st_alphashape FUNCTION C true geometry INVOKER

args: geom, alpha, allow_holes = false - Computes an Alpha-shape enclosing a geometry

postgis_type_name FUNCTION SQL true character varying INVOKER
postgis_srs FUNCTION C true SETOF record INVOKER

args: auth_name, auth_srid - Return a metadata record for the requested authority and srid.

geography_spgist_picksplit_nd FUNCTION C true void INVOKER
st_3dlength FUNCTION C true double precision INVOKER

args: a_3dlinestring - Returns the 3D length of a linear geometry.

st_generatepoints FUNCTION C false geometry INVOKER

args: g, npoints, seed = 0 - Generates random points contained in a Polygon or MultiPolygon.

st_buildarea FUNCTION C true geometry INVOKER

args: geom - Creates a polygonal geometry formed by the linework of a geometry.

st_area FUNCTION C true double precision INVOKER
st_seteffectivearea FUNCTION C true geometry INVOKER

args: geomA, threshold = 0, set_area = 1 - Sets the effective area for each vertex, using the Visvalingam-Whyatt algorithm.

postgis_proj_version FUNCTION C true text INVOKER

Returns the version number of the PROJ4 library.

st_pointfromtext FUNCTION SQL true geometry INVOKER
st_geomfromtext FUNCTION C true geometry INVOKER
st_patchn FUNCTION SQL true geometry INVOKER

args: geomA, n - Returns the Nth geometry (face) of a PolyhedralSurface.

st_rotate FUNCTION SQL true geometry INVOKER

args: geomA, rotRadians, pointOrigin - Rotates a geometry about an origin point.

text FUNCTION C true text INVOKER
st_hasarc FUNCTION C true boolean INVOKER

args: geomA - Tests if a geometry contains a circular arc

st_relatematch FUNCTION C true boolean INVOKER
st_issolid FUNCTION C true boolean INVOKER

args: geom1 - Test if the geometry is a solid. No validity check is performed.

_st_longestline FUNCTION C true geometry INVOKER
_st_sortablehash FUNCTION C true bigint INVOKER
st_snaptogrid FUNCTION C true geometry INVOKER

args: geomA, pointOrigin, sizeX, sizeY, sizeZ, sizeM - Snap all points of the input geometry to a regular grid.

st_segmentize FUNCTION C true geography INVOKER

args: geog, max_segment_length - Returns a modified geometry/geography having no segment longer than a given distance.

geom4d_brin_inclusion_add_value FUNCTION C false boolean INVOKER
st_3ddifference FUNCTION C true geometry INVOKER

args: geom1, geom2 - Perform 3D difference

st_pointinsidecircle FUNCTION C true boolean INVOKER
st_setpoint FUNCTION C true geometry INVOKER

args: linestring, zerobasedposition, point - Replace point of a linestring with a given point.

enablelongtransactions FUNCTION PLPGSQL false text INVOKER

Enables long transaction support.

geometry_overlaps_nd FUNCTION C true boolean INVOKER
_st_3ddwithin FUNCTION C true boolean INVOKER
st_linefromwkb FUNCTION SQL true geometry INVOKER
geometry_same FUNCTION C true boolean INVOKER
geometry_distance_centroid FUNCTION C true double precision INVOKER
st_makebox2d FUNCTION C true box2d INVOKER

args: pointLowLeft, pointUpRight - Creates a BOX2D defined by two 2D point geometries.

st_buffer FUNCTION SQL true geography INVOKER
metaphone FUNCTION C true text INVOKER
geometry_in FUNCTION C true geometry INVOKER
st_ymin FUNCTION C true double precision INVOKER

args: aGeomorBox2DorBox3D - Returns the Y minima of a 2D or 3D bounding box or a geometry.

postgis_constraint_dims FUNCTION SQL false integer INVOKER
geometry_contains FUNCTION C true boolean INVOKER
st_addmeasure FUNCTION C true geometry INVOKER

args: geom_mline, measure_start, measure_end - Interpolates measures along a linear geometry.

geometry_contains_3d FUNCTION C true boolean INVOKER
st_orientedenvelope FUNCTION C true geometry INVOKER

args: geom - Returns a minimum-area rectangle containing a geometry.

st_askml FUNCTION C true text INVOKER
postgis_sfcgal_noop FUNCTION C true geometry INVOKER
st_estimatedextent FUNCTION C false box2d INVOKER

args: table_name, geocolumn_name - Returns the estimated extent of a spatial table.

geography_gist_penalty FUNCTION C false internal INVOKER
geometry_le FUNCTION C true boolean INVOKER
st_orderingequals FUNCTION C true boolean INVOKER
populate_geometry_columns FUNCTION PLPGSQL false text INVOKER

args: relation_oid, use_typmod=true - Ensures geometry columns are defined with type modifiers or have appropriate spatial constraints.

st_interpolatepoint FUNCTION C true double precision INVOKER

args: linear_geom_with_measure, point - Returns the interpolated measure of a geometry closest to a point.

st_asewkt FUNCTION C true text INVOKER
geometry_gist_penalty_nd FUNCTION C false internal INVOKER
st_dwithin FUNCTION C true boolean INVOKER
st_summary FUNCTION C true text INVOKER

args: g - Returns a text summary of the contents of a geometry.

st_forcecurve FUNCTION C true geometry INVOKER

args: g - Upcast a geometry into its curved type, if applicable.

geometry_same_nd FUNCTION C true boolean INVOKER
geometry_lt FUNCTION C true boolean INVOKER
st_simplifyvw FUNCTION C true geometry INVOKER

args: geomA, tolerance - Returns a simplified version of a geometry, using the Visvalingam-Whyatt algorithm

box3dtobox FUNCTION C true box INVOKER
dmetaphone_alt FUNCTION C true text INVOKER
st_optimalalphashape FUNCTION C true geometry INVOKER

args: geom, allow_holes = false, nb_components = 1 - Computes an Alpha-shape enclosing a geometry using an “optimal” alpha value.

_st_linecrossingdirection FUNCTION C true integer INVOKER
geography_spgist_choose_nd FUNCTION C true void INVOKER
st_tesselate FUNCTION C true geometry INVOKER

args: geom - Perform surface Tesselation of a polygon or polyhedralsurface and returns as a TIN or collection of TINS

gidx_in FUNCTION C true gidx INVOKER
st_dimension FUNCTION C true integer INVOKER

args: g - Returns the topological dimension of a geometry.

_postgis_scripts_pgsql_version FUNCTION SQL true text INVOKER
st_forcepolygoncw FUNCTION C true geometry INVOKER

args: geom - Orients all exterior rings clockwise and all interior rings counter-clockwise.

st_3dmaxdistance FUNCTION C true double precision INVOKER

args: g1, g2 - Returns the 3D cartesian maximum distance (based on spatial ref) between two geometries in projected units.

st_pointonsurface FUNCTION C true geometry INVOKER

args: g1 - Computes a point guaranteed to lie in a polygon, or on a geometry.

geog_brin_inclusion_add_value FUNCTION C false boolean INVOKER
st_wrapx FUNCTION C true geometry INVOKER

args: geom, wrap, move - Wrap a geometry around an X value.

st_symmetricdifference FUNCTION SQL false geometry INVOKER
_st_3dintersects FUNCTION C true boolean INVOKER
st_memsize FUNCTION C true integer INVOKER

args: geomA - Returns the amount of memory space a geometry takes.

st_translate FUNCTION SQL true geometry INVOKER

args: g1, deltax, deltay, deltaz - Translates a geometry by given offsets.

_st_coveredby FUNCTION C true boolean INVOKER
st_dumprings FUNCTION C true SETOF geometry_dump INVOKER

args: a_polygon - Returns a set of geometry_dump rows for the exterior and interior rings of a Polygon.

st_length2dspheroid FUNCTION C true double precision INVOKER
geometry_gist_distance_2d FUNCTION C false double precision INVOKER
_st_geomfromgml FUNCTION C true geometry INVOKER
geometry_gist_consistent_nd FUNCTION C false boolean INVOKER
_st_voronoi FUNCTION C true geometry INVOKER
geometry_spgist_leaf_consistent_nd FUNCTION C true boolean INVOKER
st_distancecpa FUNCTION C true double precision INVOKER

args: track1, track2 - Returns the distance between the closest point of approach of two trajectories.

pgis_geometry_union_parallel_transfn FUNCTION C true internal INVOKER
st_asewkb FUNCTION C true bytea INVOKER
geography_gist_same FUNCTION C false internal INVOKER
st_pointzm FUNCTION C true geometry INVOKER

args: x, y, z, m, srid=unknown - Creates a Point with X, Y, Z, M and SRID values.

st_polyfromtext FUNCTION SQL true geometry INVOKER
st_clusterwithin FUNCTION INTERNAL true ARRAY INVOKER
st_srid FUNCTION C true integer INVOKER
st_ashexewkb FUNCTION C true text INVOKER
pgis_geometry_union_parallel_finalfn FUNCTION C true geometry INVOKER
geometry_hash FUNCTION C true integer INVOKER
postgis_sfcgal_scripts_installed FUNCTION SQL true text INVOKER
_st_asx3d FUNCTION C true text INVOKER
geometry_spgist_compress_nd FUNCTION C true internal INVOKER
geometry_distance_centroid_nd FUNCTION C true double precision INVOKER
st_dfullywithin FUNCTION C true boolean INVOKER
st_scale FUNCTION C true geometry INVOKER

args: geom, factor, origin - Scales a geometry by given factors.

st_makepolygon FUNCTION C true geometry INVOKER

args: outerlinestring, interiorlinestrings - Creates a Polygon from a shell and optional list of holes.

st_polygonfromwkb FUNCTION SQL true geometry INVOKER
st_3dextent AGGREGATE INTERNAL true box3d INVOKER

args: geomfield - Aggregate function that returns the 3D bounding box of geometries.

dropgeometrytable FUNCTION PLPGSQL false text INVOKER

args: catalog_name, schema_name, table_name - Drops a table and all its references in geometry_columns.

dropgeometrycolumn FUNCTION PLPGSQL false text INVOKER

args: catalog_name, schema_name, table_name, column_name - Removes a geometry column from a spatial table.

st_geomfromgeohash FUNCTION SQL true geometry INVOKER
st_asmvt AGGREGATE INTERNAL true bytea INVOKER
geometry_sortsupport FUNCTION C true void INVOKER
st_geomfromewkb FUNCTION C true geometry INVOKER
st_length FUNCTION C true double precision INVOKER
box FUNCTION C true box INVOKER
parse_address FUNCTION C true record INVOKER
postgis_scripts_installed FUNCTION SQL true text INVOKER

Returns version of the PostGIS scripts installed in this database.

box2d_out FUNCTION C true cstring INVOKER
st_geomfromewkt FUNCTION C true geometry INVOKER
st_geogfromtext FUNCTION C true geography INVOKER
st_asmvtgeom FUNCTION C true geometry INVOKER
st_geomfromgeojson FUNCTION C true geometry INVOKER
st_multi FUNCTION C true geometry INVOKER

args: geom - Return the geometry as a MULTI* geometry.

st_snap FUNCTION C true geometry INVOKER

args: input, reference, tolerance - Snap segments and vertices of input geometry to vertices of a reference geometry.

st_minimumclearance FUNCTION C true double precision INVOKER

args: g - Returns the minimum clearance of a geometry, a measure of a geometrys robustness.

st_ispolygoncw FUNCTION C true boolean INVOKER

args: geom - Tests if Polygons have exterior rings oriented clockwise and interior rings oriented counter-clockwise.

_st_pointoutside FUNCTION C true geography INVOKER
st_interiorringn FUNCTION C true geometry INVOKER

args: a_polygon, n - Returns the Nth interior ring (hole) of a Polygon.

overlaps_2d FUNCTION C true boolean INVOKER
geography_spgist_compress_nd FUNCTION C true internal INVOKER
postgis_lib_revision FUNCTION C true text INVOKER
_postgis_index_extent FUNCTION C false box2d INVOKER
geometry_within_nd FUNCTION C true boolean INVOKER
st_m FUNCTION C true double precision INVOKER

args: a_point - Returns the M coordinate of a Point.

st_wkttosql FUNCTION C true geometry INVOKER
st_makepointm FUNCTION C true geometry INVOKER

args: x, y, m - Creates a Point from X, Y and M values.

st_reverse FUNCTION C true geometry INVOKER

args: g1 - Return the geometry with vertex order reversed.

st_forcelhr FUNCTION C true geometry INVOKER

args: geom - Force LHR orientation

checkauthtrigger FUNCTION C false trigger INVOKER
st_touches FUNCTION C true boolean INVOKER
st_isvalidreason FUNCTION C true text INVOKER

args: geomA, flags - Returns text stating if a geometry is valid, or a reason for invalidity.

st_distancespheroid FUNCTION C true double precision INVOKER
st_zmin FUNCTION C true double precision INVOKER

args: aGeomorBox2DorBox3D - Returns the Z minima of a 2D or 3D bounding box or a geometry.

st_linelocatepoint FUNCTION C true double precision INVOKER
geometry_above FUNCTION C true boolean INVOKER
st_z FUNCTION C true double precision INVOKER

args: a_point - Returns the Z coordinate of a Point.

pgis_geometry_accum_transfn FUNCTION C false internal INVOKER
st_y FUNCTION C true double precision INVOKER

args: a_point - Returns the Y coordinate of a Point.

st_x FUNCTION C true double precision INVOKER

args: a_point - Returns the X coordinate of a Point.

st_3dlongestline FUNCTION C true geometry INVOKER

args: g1, g2 - Returns the 3D longest line between two geometries

geography_spgist_leaf_consistent_nd FUNCTION C true boolean INVOKER
st_mpointfromtext FUNCTION SQL true geometry INVOKER
st_collectionextract FUNCTION C true geometry INVOKER

args: collection, type - Given a geometry collection, returns a multi-geometry containing only elements of a specified type.

st_3ddwithin FUNCTION C true boolean INVOKER
st_box2dfromgeohash FUNCTION C true box2d INVOKER
st_makevalid FUNCTION C true geometry INVOKER

args: input, params - Attempts to make an invalid geometry valid without losing vertices.

equals FUNCTION C true boolean INVOKER
geometry_overlaps FUNCTION C true boolean INVOKER
geography_overlaps FUNCTION C true boolean INVOKER
geography_out FUNCTION C true cstring INVOKER
st_coveredby FUNCTION C true boolean INVOKER
spheroid_in FUNCTION C true spheroid INVOKER
st_asbinary FUNCTION C true bytea INVOKER
st_simplifypreservetopology FUNCTION C true geometry INVOKER

args: geomA, tolerance - Returns a simplified and valid version of a geometry, using the Douglas-Peucker algorithm.

geometrytype FUNCTION C true text INVOKER
postgis_scripts_released FUNCTION C true text INVOKER

Returns the version number of the postgis.sql script released with the installed PostGIS lib.

st_convexhull FUNCTION C true geometry INVOKER

args: geomA - Computes the convex hull of a geometry.

postgis_geos_version FUNCTION C true text INVOKER

Returns the version number of the GEOS library.

pgis_geometry_collect_finalfn FUNCTION C false geometry INVOKER
point FUNCTION C true point INVOKER
st_dumppoints FUNCTION C true SETOF geometry_dump INVOKER

args: geom - Returns a set of geometry_dump rows for the coordinates in a geometry.

_st_distancetree FUNCTION C true double precision INVOKER
st_points FUNCTION C true geometry INVOKER

args: geom - Returns a MultiPoint containing the coordinates of a geometry.

geometry_send FUNCTION C true bytea INVOKER
polygon FUNCTION C true polygon INVOKER
geometry_gist_same_nd FUNCTION C false internal INVOKER
st_expand FUNCTION C true box3d INVOKER

args: box, dx, dy, dz=0 - Returns a bounding box expanded from another bounding box or a geometry.

st_simplifypolygonhull FUNCTION C true geometry INVOKER

args: param_geom, vertex_fraction, is_outer = true - Computes a simplifed topology-preserving outer or inner hull of a polygonal geometry.

pgis_asmvt_serialfn FUNCTION C true bytea INVOKER
geometry_spgist_inner_consistent_3d FUNCTION C true void INVOKER
st_ymax FUNCTION C true double precision INVOKER

args: aGeomorBox2DorBox3D - Returns the Y maxima of a 2D or 3D bounding box or a geometry.

st_pointz FUNCTION C true geometry INVOKER

args: x, y, z, srid=unknown - Creates a Point with X, Y, Z and SRID values.

_st_dwithin FUNCTION C true boolean INVOKER
box2df_in FUNCTION C true box2df INVOKER
st_transscale FUNCTION SQL true geometry INVOKER

args: geomA, deltaX, deltaY, XFactor, YFactor - Translates and scales a geometry by given offsets and factors.

geometry_overright FUNCTION C true boolean INVOKER
geometry_spgist_compress_2d FUNCTION C true internal INVOKER
st_iscollection FUNCTION C true boolean INVOKER

args: g - Tests if a geometry is a geometry collection type.

disablelongtransactions FUNCTION PLPGSQL false text INVOKER

Disables long transaction support.

st_assvg FUNCTION C true text INVOKER
pgis_geometry_union_parallel_serialfn FUNCTION C true bytea INVOKER
st_removepoint FUNCTION C true geometry INVOKER

args: linestring, offset - Remove a point from a linestring.

postgis_libjson_version FUNCTION C true text INVOKER
geometry_spgist_config_3d FUNCTION C true void INVOKER
st_simplify FUNCTION C true geometry INVOKER

args: geomA, tolerance, preserveCollapsed - Returns a simplified version of a geometry, using the Douglas-Peucker algorithm.

st_mpolyfromtext FUNCTION SQL true geometry INVOKER
st_3dshortestline FUNCTION C true geometry INVOKER

args: g1, g2 - Returns the 3D shortest line between two geometries

postgis_sfcgal_version FUNCTION C true text INVOKER

Returns the version of SFCGAL in use

_st_covers FUNCTION C true boolean INVOKER
_st_orderingequals FUNCTION C true boolean INVOKER
st_point FUNCTION C true geometry INVOKER

args: x, y, srid=unknown - Creates a Point with X, Y and SRID values.

st_mpointfromwkb FUNCTION SQL true geometry INVOKER
geometry_spgist_leaf_consistent_3d FUNCTION C true boolean INVOKER
st_intersects FUNCTION C true boolean INVOKER
st_area2d FUNCTION C true double precision INVOKER
st_within FUNCTION C true boolean INVOKER
st_3dlineinterpolatepoint FUNCTION C true geometry INVOKER

args: a_linestring, a_fraction - Returns a point interpolated along a 3D line at a fractional location.

st_locatebetween FUNCTION C true geometry INVOKER

args: geom, measure_start, measure_end, offset = 0 - Returns the portions of a geometry that match a measure range.

st_disjoint FUNCTION C true boolean INVOKER
geometry_spgist_compress_3d FUNCTION C true internal INVOKER
geography_in FUNCTION C true geography INVOKER
geometry_same_3d FUNCTION C true boolean INVOKER
pgis_geometry_union_parallel_combinefn FUNCTION C true internal INVOKER
st_angle FUNCTION SQL true double precision INVOKER

args: line1, line2 - Returns the angle between two vectors defined by 3 or 4 points, or 2 lines.

postgis_hasbbox FUNCTION C true boolean INVOKER

args: geomA - Returns TRUE if the bbox of this geometry is cached, FALSE otherwise.

st_polyfromwkb FUNCTION SQL true geometry INVOKER
postgis_svn_version FUNCTION SQL true text INVOKER
overlaps_geog FUNCTION C true boolean INVOKER
postgis_srs_search FUNCTION C true SETOF record INVOKER

args: bounds, auth_name=EPSG - Return metadata records for projected coordinate systems that have areas of useage that fully contain the bounds parameter.

geometry_spgist_picksplit_nd FUNCTION C true void INVOKER
geography_spgist_inner_consistent_nd FUNCTION C true void INVOKER
postgis_constraint_srid FUNCTION SQL false integer INVOKER
st_dump FUNCTION C true SETOF geometry_dump INVOKER

args: g1 - Returns a set of geometry_dump rows for the components of a geometry.

st_clipbybox2d FUNCTION C true geometry INVOKER

args: geom, box - Computes the portion of a geometry falling within a rectangle.

st_polygonize FUNCTION INTERNAL true geometry INVOKER

args: geom_array - Computes a collection of polygons formed from the linework of a set of geometries.

st_difference FUNCTION C true geometry INVOKER

args: geomA, geomB, gridSize = -1 - Computes a geometry representing the part of geometry A that does not intersect geometry B.

st_contains FUNCTION C true boolean INVOKER
st_coverageinvalidedges WINDOW C true geometry INVOKER

args: geom, tolerance = 0 - Window function that finds locations where polygons fail to form a valid coverage.

st_cleangeometry FUNCTION C true geometry INVOKER
gidx_out FUNCTION C true cstring INVOKER
st_3ddistance FUNCTION C true double precision INVOKER

args: g1, g2 - Returns the 3D cartesian minimum distance (based on spatial ref) between two geometries in projected units.

st_offsetcurve FUNCTION C true geometry INVOKER

args: line, signed_distance, style_parameters=’ - Returns an offset line at a given distance and side from an input line.

st_subdivide FUNCTION C true SETOF geometry INVOKER

args: geom, max_vertices=256, gridSize = -1 - Computes a rectilinear subdivision of a geometry.

lockrow FUNCTION SQL false integer INVOKER
geometry_overlaps_3d FUNCTION C true boolean INVOKER
st_polygonfromtext FUNCTION SQL true geometry INVOKER
st_numpatches FUNCTION SQL true integer INVOKER

args: g1 - Return the number of faces on a Polyhedral Surface. Will return null for non-polyhedral geometries.

geometry_within FUNCTION C true boolean INVOKER
st_numinteriorring FUNCTION C true integer INVOKER

args: a_polygon - Returns the number of interior rings (holes) of a Polygon. Aias for ST_NumInteriorRings

st_hausdorffdistance FUNCTION C true double precision INVOKER

args: g1, g2, densifyFrac - Returns the Hausdorff distance between two geometries.

pgis_asgeobuf_transfn FUNCTION C true internal INVOKER
st_centroid FUNCTION C true geography INVOKER
st_rotatex FUNCTION SQL true geometry INVOKER

args: geomA, rotRadians - Rotates a geometry about the X axis.

longtransactionsenabled FUNCTION PLPGSQL false boolean INVOKER
st_intersection FUNCTION SQL true geography INVOKER
st_reduceprecision FUNCTION C true geometry INVOKER

args: g, gridsize - Returns a valid geometry with points rounded to a grid tolerance.

st_length2d FUNCTION C true double precision INVOKER

args: a_2dlinestring - Returns the 2D length of a linear geometry. Alias for ST_Length

geography_ge FUNCTION C true boolean INVOKER
st_3dperimeter FUNCTION C true double precision INVOKER

args: geomA - Returns the 3D perimeter of a polygonal geometry.

st_xmax FUNCTION C true double precision INVOKER

args: aGeomorBox2DorBox3D - Returns the X maxima of a 2D or 3D bounding box or a geometry.

st_azimuth FUNCTION C true double precision INVOKER

args: origin, target - Returns the north-based azimuth of a line between two points.

overlaps_nd FUNCTION C true boolean INVOKER
geometry_spgist_inner_consistent_2d FUNCTION C true void INVOKER
postgis_lib_build_date FUNCTION C true text INVOKER

Returns build date of the PostGIS library.

spheroid_out FUNCTION C true cstring INVOKER
st_filterbym FUNCTION C true geometry INVOKER

args: geom, min, max = null, returnM = false - Removes vertices based on their M value

geometry_right FUNCTION C true boolean INVOKER
gserialized_gist_joinsel_2d FUNCTION C false double precision INVOKER
_st_maxdistance FUNCTION C true double precision INVOKER
geography_gt FUNCTION C true boolean INVOKER
st_volume FUNCTION C true double precision INVOKER

args: geom1 - Computes the volume of a 3D solid. If applied to surface (even closed) geometries will return 0.

geography_gist_compress FUNCTION C false internal INVOKER
st_3darea FUNCTION C true double precision INVOKER

args: geom1 - Computes area of 3D surface geometries. Will return 0 for solids.

st_node FUNCTION C true geometry INVOKER

args: geom - Nodes a collection of lines.

geometry_spgist_config_2d FUNCTION C true void INVOKER
st_asencodedpolyline FUNCTION C true text INVOKER
st_linefrommultipoint FUNCTION C true geometry INVOKER

args: aMultiPoint - Creates a LineString from a MultiPoint geometry.

geometry_out FUNCTION C true cstring INVOKER
geometry_left FUNCTION C true boolean INVOKER
st_extent AGGREGATE INTERNAL true box2d INVOKER

args: geomfield - Aggregate function that returns the bounding box of geometries.

geometry_gist_compress_2d FUNCTION C false internal INVOKER
st_3dunion AGGREGATE INTERNAL true geometry INVOKER

args: g1field - Perform 3D union.

st_affine FUNCTION C true geometry INVOKER

args: geomA, a, b, d, e, xoff, yoff - Apply a 3D affine transformation to a geometry.

pgis_geometry_clusterintersecting_finalfn FUNCTION C false ARRAY INVOKER
st_xmin FUNCTION C true double precision INVOKER

args: aGeomorBox2DorBox3D - Returns the X minima of a 2D or 3D bounding box or a geometry.

geometry_gist_same_2d FUNCTION C false internal INVOKER
st_forcepolygonccw FUNCTION SQL true geometry INVOKER

args: geom - Orients all exterior rings counter-clockwise and all interior rings clockwise.

box3d FUNCTION C true box3d INVOKER
st_memunion AGGREGATE INTERNAL true geometry INVOKER

args: geomfield - Aggregate function which unions geometries in a memory-efficent but slower way

_st_intersects FUNCTION C true boolean INVOKER
st_rotatey FUNCTION SQL true geometry INVOKER

args: geomA, rotRadians - Rotates a geometry about the Y axis.

st_rotatez FUNCTION SQL true geometry INVOKER

args: geomA, rotRadians - Rotates a geometry about the Z axis.

unlockrows FUNCTION PLPGSQL false integer INVOKER

args: auth_token - Removes all locks held by an authorization token.

_postgis_selectivity FUNCTION C false double precision INVOKER
geometry_distance_cpa FUNCTION C true double precision INVOKER
text_soundex FUNCTION C true text INVOKER
postgis_libprotobuf_version FUNCTION C true text INVOKER
geography_eq FUNCTION C true boolean INVOKER
st_zmax FUNCTION C true double precision INVOKER

args: aGeomorBox2DorBox3D - Returns the Z maxima of a 2D or 3D bounding box or a geometry.

st_numpoints FUNCTION C true integer INVOKER

args: g1 - Returns the number of points in a LineString or CircularString.

geography_distance_knn FUNCTION C true double precision INVOKER
postgis_typmod_dims FUNCTION C true integer INVOKER
geography_recv FUNCTION C true geography INVOKER
st_3dclosestpoint FUNCTION C true geometry INVOKER

args: g1, g2 - Returns the 3D point on g1 that is closest to g2. This is the first point of the 3D shortest line.

geometry_eq FUNCTION C true boolean INVOKER
geometry_below FUNCTION C true boolean INVOKER
postgis_addbbox FUNCTION C true geometry INVOKER

args: geomA - Add bounding box to the geometry.

st_cpawithin FUNCTION C true boolean INVOKER

args: track1, track2, dist - Tests if the closest point of approach of two trajectoriesis within the specified distance.

postgis_constraint_type FUNCTION SQL false character varying INVOKER
_st_equals FUNCTION C true boolean INVOKER
geometry_spgist_inner_consistent_nd FUNCTION C true void INVOKER
st_locatebetweenelevations FUNCTION C true geometry INVOKER

args: geom, elevation_start, elevation_end - Returns the portions of a geometry that lie in an elevation (Z) range.

st_perimeter2d FUNCTION C true double precision INVOKER

args: geomA - Returns the 2D perimeter of a polygonal geometry. Alias for ST_Perimeter.

pgis_asflatgeobuf_finalfn FUNCTION C true bytea INVOKER
postgis_scripts_build_date FUNCTION SQL true text INVOKER

Returns build date of the PostGIS scripts.

geography_gist_consistent FUNCTION C false boolean INVOKER
st_linecrossingdirection FUNCTION C true integer INVOKER
st_ndims FUNCTION C true smallint INVOKER

args: g1 - Returns the coordinate dimension of a geometry.

st_fromflatgeobuf FUNCTION C true SETOF anyelement INVOKER
st_bdmpolyfromtext FUNCTION PLPGSQL true geometry INVOKER
difference FUNCTION C true integer INVOKER
postgis_cache_bbox FUNCTION C false trigger INVOKER
geometry_spgist_leaf_consistent_2d FUNCTION C true boolean INVOKER
gserialized_gist_joinsel_nd FUNCTION C false double precision INVOKER
geometry_spgist_picksplit_2d FUNCTION C true void INVOKER
st_astext FUNCTION C true text INVOKER
box3d_in FUNCTION C true box3d INVOKER
geography_gist_distance FUNCTION C false double precision INVOKER
box2df_out FUNCTION C true cstring INVOKER
geometry_spgist_config_nd FUNCTION C true void INVOKER
_st_bestsrid FUNCTION C true integer INVOKER
_st_crosses FUNCTION C true boolean INVOKER
geometry_ge FUNCTION C true boolean INVOKER
geometry_contains_nd FUNCTION C true boolean INVOKER
pgis_asmvt_combinefn FUNCTION C true internal INVOKER
st_pointm FUNCTION C true geometry INVOKER

args: x, y, m, srid=unknown - Creates a Point with X, Y, M and SRID values.

geometry_spgist_picksplit_3d FUNCTION C true void INVOKER
st_mlinefromwkb FUNCTION SQL true geometry INVOKER
box2d FUNCTION C true box2d INVOKER
st_pointn FUNCTION C true geometry INVOKER

args: a_linestring, n - Returns the Nth point in the first LineString or circular LineString in a geometry.

geometry_gt FUNCTION C true boolean INVOKER
geometry_overbelow FUNCTION C true boolean INVOKER
st_asmarc21 FUNCTION C true text INVOKER
st_dumpsegments FUNCTION C true SETOF geometry_dump INVOKER

args: geom - Returns a set of geometry_dump rows for the segments in a geometry.

st_geohash FUNCTION C true text INVOKER
geometry_gist_decompress_nd FUNCTION C false internal INVOKER
levenshtein_less_equal FUNCTION C true integer INVOKER
st_frechetdistance FUNCTION C true double precision INVOKER

args: g1, g2, densifyFrac = -1 - Returns the Fréchet distance between two geometries.

st_bdpolyfromtext FUNCTION PLPGSQL true geometry INVOKER
postgis_getbbox FUNCTION C true box2d INVOKER
st_sharedpaths FUNCTION C true geometry INVOKER

args: lineal1, lineal2 - Returns a collection containing paths shared by the two input linestrings/multilinestrings.

_st_touches FUNCTION C true boolean INVOKER
st_collect AGGREGATE C true geometry INVOKER

args: g1field - Creates a GeometryCollection or Multi* geometry from a set of geometries.

_st_contains FUNCTION C true boolean INVOKER
st_isclosed FUNCTION C true boolean INVOKER

args: g - Tests if a LineStringss start and end points are coincident. For a PolyhedralSurface tests if it is closed (volumetric).

postgis_index_supportfn FUNCTION C false internal INVOKER
st_pointfromwkb FUNCTION SQL true geometry INVOKER
st_geometrytype FUNCTION C true text INVOKER

args: g1 - Returns the SQL-MM type of a geometry as text.

st_curvetoline FUNCTION C true geometry INVOKER

args: curveGeom, tolerance, tolerance_type, flags - Converts a geometry containing curves to a linear geometry.

geography_gist_picksplit FUNCTION C false internal INVOKER
st_geomfromtwkb FUNCTION C true geometry INVOKER
st_geomfromwkb FUNCTION C true geometry INVOKER
st_npoints FUNCTION C true integer INVOKER

args: g1 - Returns the number of points (vertices) in a geometry.

st_union AGGREGATE C true geometry INVOKER

args: g1field, gridSize - Computes a geometry representing the point-set union of the input geometries.

st_3ddfullywithin FUNCTION C true boolean INVOKER
geography_analyze FUNCTION C false boolean INVOKER
st_approximatemedialaxis FUNCTION C true geometry INVOKER

args: geom - Compute the approximate medial axis of an areal geometry.

st_isring FUNCTION C true boolean INVOKER

args: g - Tests if a LineString is closed and simple.

st_coveragesimplify WINDOW C true geometry INVOKER

args: geom, tolerance, simplifyBoundary = true - Window function that simplifies the edges of a polygonal coverage.

st_locatealong FUNCTION C true geometry INVOKER

args: geom_with_measure, measure, offset = 0 - Returns the point(s) on a geometry that match a measure value.

st_perimeter FUNCTION C true double precision INVOKER

args: geog, use_spheroid = true - Returns the length of the boundary of a polygonal geometry or geography.

st_aslatlontext FUNCTION C true text INVOKER
_postgis_join_selectivity FUNCTION C false double precision INVOKER
st_lineinterpolatepoint FUNCTION C true geography INVOKER
st_geometryfromtext FUNCTION C true geometry INVOKER
geometry_spgist_choose_nd FUNCTION C true void INVOKER
box2d_in FUNCTION C true box2d INVOKER
st_force2d FUNCTION C true geometry INVOKER

args: geomA - Force the geometries into a “2-dimensional mode”.

pgis_asmvt_transfn FUNCTION C true internal INVOKER
pgis_asgeobuf_finalfn FUNCTION C true bytea INVOKER
postgis_geos_compiled_version FUNCTION C true text INVOKER

Returns the version number of the GEOS library against which PostGIS was built.

st_distancesphere FUNCTION SQL true double precision INVOKER
gserialized_gist_sel_nd FUNCTION C false double precision INVOKER
geography_spgist_config_nd FUNCTION C true void INVOKER
st_multilinestringfromtext FUNCTION SQL true geometry INVOKER
st_fromflatgeobuftotable FUNCTION C true void INVOKER
st_transform FUNCTION C true geometry INVOKER

args: geom, from_proj, to_srid - Return a new geometry with coordinates transformed to a different spatial reference system.

pgis_asmvt_finalfn FUNCTION C true bytea INVOKER
postgis_liblwgeom_version FUNCTION C true text INVOKER

Returns the version number of the liblwgeom library. This should match the version of PostGIS.

st_geomfrommarc21 FUNCTION C true geometry INVOKER
pgis_geometry_polygonize_finalfn FUNCTION C false geometry INVOKER
st_covers FUNCTION C true boolean INVOKER
st_distance FUNCTION C true double precision INVOKER
st_multipolyfromwkb FUNCTION SQL true geometry INVOKER
st_multipolygonfromtext FUNCTION SQL true geometry INVOKER
st_force3dm FUNCTION C true geometry INVOKER

args: geomA, Mvalue = 0.0 - Force the geometries into XYM mode.

checkauth FUNCTION PLPGSQL false integer INVOKER

args: a_table_name, a_key_column_name - Creates a trigger on a table to prevent/allow updates and deletes of rows based on authorization token.

st_nrings FUNCTION C true integer INVOKER

args: geomA - Returns the number of rings in a polygonal geometry.

st_clusterintersecting FUNCTION INTERNAL true ARRAY INVOKER
st_makesolid FUNCTION C true geometry INVOKER

args: geom1 - Cast the geometry into a solid. No check is performed. To obtain a valid solid, the input geometry must be a closed Polyhedral Surface or a closed TIN.

st_mlinefromtext FUNCTION SQL true geometry INVOKER
st_crosses FUNCTION C true boolean INVOKER
geometry_gist_picksplit_2d FUNCTION C false internal INVOKER
st_square FUNCTION C true geometry INVOKER

args: size, cell_i, cell_j, origin - Returns a single square, using the provided edge size and cell coordinate within the square grid space.

st_force3dz FUNCTION C true geometry INVOKER

args: geomA, Zvalue = 0.0 - Force the geometries into XYZ mode.

st_findextent FUNCTION PLPGSQL false box2d INVOKER
geometry_distance_box FUNCTION C true double precision INVOKER
st_isvalidtrajectory FUNCTION C true boolean INVOKER

args: line - Tests if the geometry is a valid trajectory.

st_multipointfromtext FUNCTION SQL true geometry INVOKER
st_coorddim FUNCTION C true smallint INVOKER

args: geomA - Return the coordinate dimension of a geometry.

st_force4d FUNCTION C true geometry INVOKER

args: geomA, Zvalue = 0.0, Mvalue = 0.0 - Force the geometries into XYZM mode.

st_linetocurve FUNCTION C true geometry INVOKER

args: geomANoncircular - Converts a linear geometry to a curved geometry.

postgis_libxml_version FUNCTION C true text INVOKER

Returns the version number of the libxml2 library.

st_orientation FUNCTION C true integer INVOKER

args: geom - Determine surface orientation

geometry_spgist_choose_3d FUNCTION C true void INVOKER
geography_lt FUNCTION C true boolean INVOKER
st_closestpointofapproach FUNCTION C true double precision INVOKER

args: track1, track2 - Returns a measure at the closest point of approach of two trajectories.

st_ispolygonccw FUNCTION C true boolean INVOKER

args: geom - Tests if Polygons have exterior rings oriented counter-clockwise and interior rings oriented clockwise.

st_lengthspheroid FUNCTION C true double precision INVOKER

args: a_geometry, a_spheroid - Returns the 2D or 3D length/perimeter of a lon/lat geometry on a spheroid.

st_largestemptycircle FUNCTION C true record INVOKER

args: geom, tolerance=0.0, boundary=POINT EMPTY - Computes the largest circle not overlapping a geometry.

st_normalize FUNCTION C true geometry INVOKER

args: geom - Return the geometry in its canonical form.

st_concavehull FUNCTION C true geometry INVOKER

args: param_geom, param_pctconvex, param_allow_holes = false - Computes a possibly concave geometry that contains all input geometry vertices

geometry_gist_decompress_2d FUNCTION C false internal INVOKER
_st_overlaps FUNCTION C true boolean INVOKER
st_endpoint FUNCTION C true geometry INVOKER

args: g - Returns the last point of a LineString or CircularLineString.

st_longestline FUNCTION SQL true geometry INVOKER

args: g1, g2 - Returns the 2D longest line between two geometries.

geometry_spgist_choose_2d FUNCTION C true void INVOKER
soundex FUNCTION C true text INVOKER
postgis_noop FUNCTION C true geometry INVOKER
st_force3d FUNCTION SQL true geometry INVOKER

args: geomA, Zvalue = 0.0 - Force the geometries into XYZ mode. This is an alias for ST_Force3DZ.

st_relate FUNCTION C true text INVOKER
st_clusterintersectingwin WINDOW C true integer INVOKER

args: geom - Window function that returns a cluster id for each input geometry, clustering input geometries into connected sets.

st_squaregrid FUNCTION C true SETOF record INVOKER

args: size, bounds - Returns a set of grid squares and cell indices that completely cover the bounds of the geometry argument.

st_quantizecoordinates FUNCTION C true geometry INVOKER

args: g, prec_x, prec_y, prec_z, prec_m - Sets least significant bits of coordinates to zero

_postgis_deprecate FUNCTION PLPGSQL true void INVOKER
st_delaunaytriangles FUNCTION C true geometry INVOKER

args: g1, tolerance = 0.0, flags = 0 - Returns the Delaunay triangulation of the vertices of a geometry.

st_flipcoordinates FUNCTION C true geometry INVOKER

args: geom - Returns a version of a geometry with X and Y axis flipped.

st_minimumboundingradius FUNCTION C true record INVOKER

args: geom - Returns the center point and radius of the smallest circle that contains a geometry.

st_multipointfromwkb FUNCTION SQL true geometry INVOKER
st_makeline AGGREGATE INTERNAL true geometry INVOKER

args: geoms - Creates a LineString from Point, MultiPoint, or LineString geometries.

st_boundingdiagonal FUNCTION C true geometry INVOKER

args: geom, fits=false - Returns the diagonal of a geometrys bounding box.

st_envelope FUNCTION C true geometry INVOKER

args: g1 - Returns a geometry representing the bounding box of a geometry.

st_minimumclearanceline FUNCTION C true geometry INVOKER

args: g - Returns the two-point LineString spanning a geometrys minimum clearance.

st_minkowskisum FUNCTION C true geometry INVOKER

args: geom1, geom2 - Performs Minkowski sum

_st_expand FUNCTION C true geography INVOKER
st_gmltosql FUNCTION SQL true geometry INVOKER
st_zmflag FUNCTION C true smallint INVOKER

args: geomA - Returns a code indicating the ZM coordinate dimension of a geometry.

st_3dmakebox FUNCTION C true box3d INVOKER

args: point3DLowLeftBottom, point3DUpRightTop - Creates a BOX3D defined by two 3D point geometries.

postgis_lib_version FUNCTION C true text INVOKER

Returns the version number of the PostGIS library.

st_linestringfromwkb FUNCTION SQL true geometry INVOKER
st_hexagongrid FUNCTION C true SETOF record INVOKER

args: size, bounds - Returns a set of hexagons and cell indices that completely cover the bounds of the geometry argument.

postgis_sfcgal_full_version FUNCTION C true text INVOKER

Returns the full version of SFCGAL in use including CGAL and Boost versions

st_forcesfs FUNCTION C true geometry INVOKER

args: geomA, version - Force the geometries to use SFS 1.1 geometry types only.

st_voronoipolygons FUNCTION SQL true geometry INVOKER

args: geom, tolerance = 0.0, extend_to = NULL - Returns the cells of the Voronoi diagram of the vertices of a geometry.

geometry_overleft FUNCTION C true boolean INVOKER
st_isvaliddetail FUNCTION C true valid_detail INVOKER

args: geom, flags - Returns a valid_detail row stating if a geometry is valid or if not a reason and a location.

postgis_full_version FUNCTION PLPGSQL true text INVOKER

Reports full PostGIS version and build configuration infos.

geometry_analyze FUNCTION C false boolean INVOKER
st_asgeobuf AGGREGATE INTERNAL true bytea INVOKER
st_exteriorring FUNCTION C true geometry INVOKER

args: a_polygon - Returns a LineString representing the exterior ring of a Polygon.

geography_cmp FUNCTION C true integer INVOKER
st_geomfromgml FUNCTION C true geometry INVOKER
st_isvalid FUNCTION C true boolean INVOKER

args: g, flags - Tests if a geometry is well-formed in 2D.

st_clusterwithinwin WINDOW C true integer INVOKER

args: geom, distance - Window function that returns a cluster id for each input geometry, clustering using separation distance.

st_transformpipeline FUNCTION SQL true geometry INVOKER

args: g1, pipeline, to_srid - Return a new geometry with coordinates transformed to a different spatial reference system using a defined coordinate transformation pipeline.

st_multilinefromwkb FUNCTION SQL true geometry INVOKER
geometry_gist_compress_nd FUNCTION C false internal INVOKER
_st_within FUNCTION SQL true boolean INVOKER
postgis_typmod_srid FUNCTION C true integer INVOKER
st_voronoilines FUNCTION SQL true geometry INVOKER

args: geom, tolerance = 0.0, extend_to = NULL - Returns the boundaries of the Voronoi diagram of the vertices of a geometry.

addauth FUNCTION PLPGSQL false boolean INVOKER

args: auth_token - Adds an authorization token to be used in the current transaction.

bytea FUNCTION C true bytea INVOKER
st_closestpoint FUNCTION C true geography INVOKER
_postgis_pgsql_version FUNCTION SQL false text INVOKER
st_maxdistance FUNCTION SQL true double precision INVOKER

args: g1, g2 - Returns the 2D largest distance between two geometries in projected units.

geography_le FUNCTION C true boolean INVOKER
st_split FUNCTION C true geometry INVOKER

args: input, blade - Returns a collection of geometries created by splitting a geometry by another geometry.

box3d_out FUNCTION C true cstring INVOKER
find_srid FUNCTION PLPGSQL false integer INVOKER

args: a_schema_name, a_table_name, a_geomfield_name - Returns the SRID defined for a geometry column.