Results per Page:  
Search in: R Manuals Base Packages Help Pages | CRAN Task Views
CRAN Packages Description Help Pages News Readme Vignettes

Matching any words Matching all words
1-100 of about 300 matches
Term frequencies: convex: 2,341, hull: 1,184
Search took 0.012542 seconds

Size: 1.7K
R: Convex hull points
convex.hulls {Cluster.OBeu} R Documentation Convex hull points Description Computes points to plot a convex hull for each cluster of the clustering model Usage convex.hulls(clustering.model, data.pca)...
/CRAN/refmans/Cluster.OBeu/html/convex.hulls.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 1.6K
R: Convex hull of a set of vertices
convex.hull {igraph} R Documentation Convex hull of a set of vertices Description convex.hull() was renamed to convex_hull() to create a more consistent API. Usage convex.hull...
/CRAN/refmans/igraph/html/convex.hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 2.4K
R: Convex hull of a set of vertices
...resverts The indices of the input vertices that constritute the convex hull. rescoords The coordinates of the corners of the convex hull. Author(s) Tamas Nepusz ntamas@gmail.com References Thomas H.
/CRAN/refmans/igraph/html/convex_hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 3.3K
R: Determines if points are on the convex hull of a...
...Given a triangulation tri.obj of n points in the plane, this subroutine returns a logical vector indicating if the points (x_i,y_i) lay on the convex hull of tri.obj. Usage on.convex.hull(tri.obj, x...
/CRAN/refmans/tripack/html/on.convex.hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 3.2K
R: Determines if points are in the convex hull of a...
...a triangulation tri.obj of n points in the plane, this subroutine returns a logical vector indicating if the points (x_i,y_i) are contained within the convex hull of tri.obj. Usage in.convex.hull(tri...
/CRAN/refmans/tripack/html/in.convex.hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 3.5K
R: Return the convex hull of a triangulation object
...boundary of the convex hull. Usage convex.hull(tri.obj, plot.it=FALSE, add=FALSE,...) Arguments tri.obj object of class "tri" plot.it logical, if TRUE the convex hull of tri.obj will be plotted. add...
/CRAN/refmans/tripack/html/convex.hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 3.9K
R: Return the convex hull of a triangulation object
...the nodes on the boundary of the convex hull. ConvexHull is an experimental C++ implementation of Grahams Scan without previous triangulation, should be much faster. Usage convex.hull(tri.obj, plot.it...
/CRAN/refmans/interp/html/convex.hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 3.0K
R: Check whether treated unit is in the convex hull of donors
...unit is in the convex hull of donors Description This function finds out if the treated unit is in the convex hull of the donor units. Usage in_convex_hull(X1, X0, ...) Arguments X1 ⁠N_covars by 1...
/CRAN/refmans/pensynth/html/in_convex_hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 3.8K
R: Determines if points are on or in the convex hull of a...
...subroutine returns a logical vector indicating if the points (x_i,y_i) lay on or in the convex hull of tri.obj. Usage on.convex.hull(tri.obj, x, y, eps=1E-16) in.convex.hull(tri.obj, x, y, eps=1E-16...
/CRAN/refmans/interp/html/on.convex.hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 2.8K
R: Minimum convex hull
...Minimum convex hull Description Creates a vector convex polygon around vector features. Usage wbt_minimum_convex_hull( input, output, features = TRUE, wd = NULL, verbose_mode = NULL, compress_rasters...
/CRAN/refmans/whitebox/html/wbt_minimum_convex_hull.html
 cran-help  matching: convex, convex, convex, hull, hull and hull


Size: 2.1K
R: Gamma diversity using convex hull hypervolumes.
hull.gamma {BAT} R Documentation Gamma diversity using convex hull hypervolumes. Description Estimation of functional richness of multiple sites, based on convex hull hypervolumes. Usage hull.gamma...
/CRAN/refmans/BAT/html/hull.gamma.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 2.2K
R: Alpha diversity using convex hull hypervolumes.
hull.alpha {BAT} R Documentation Alpha diversity using convex hull hypervolumes. Description Estimation of functional richness of one or multiple sites, based on convex hull hypervolumes. Usage hull...
/CRAN/refmans/BAT/html/hull.alpha.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 2.0K
R: Add convex hull
...Add convex hull Description Adds a convex hull around the data. Usage add_hull(x, y = NULL, ...) Arguments x x values y y values ... arguments for polygon Details add_hull draws a convex hull around...
/CRAN/refmans/canprot/html/add_hull.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 4.2K
R: Non-convex hull computation
...-convex hull computation Description Legacy method for INLA::inla.nonconvex.hull() Usage fm_nonconvex_hull_inla( x, convex = -0.15, concave = convex, resolution = 40, eps = NULL, eps_rel = NULL, crs...
/CRAN/refmans/fmesher/html/fm_nonconvex_hull_inla.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 2.9K
R: Contribution of each observation to a convex hull...
...of each observation to a convex hull hypervolume. Description Contribution of each species or individual to the total volume of one or more convex hulls. Usage hull.contribution(comm, relative = FALSE)...
/CRAN/refmans/BAT/html/hull.contribution.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 3.0K
R: Convex Hull of a Set of Points
ternary_hull {isopleuros} R Documentation Convex Hull of a Set of Points Description Computes and draws the convex hull of the set of points specified. Usage ternary_hull(x, y, z, ...) ## S4 method...
/CRAN/refmans/isopleuros/html/ternary_hull.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 3.4K
R: Points from one class inside the convex hull of the points...
...the convex hull of the points from the other class Description Given two 2D data sets, Xp and Yp, it returns the Xp points inside the convex hull of Yp points. See (Okabe et al. (2000); Ceyhan (2010)...
/CRAN/refmans/pcds/html/Xin.convex.hullY.html
 cran-help  matching: convex, convex, convex, hull and hull


Size: 3.2K
R: Species-abundance distribution (SAD) using convex hulls.
hull.sad {BAT} R Documentation Species-abundance distribution (SAD) using convex hulls. Description Fits the SAD to community abundance data using convex hulls. Usage hull.sad(comm, octaves = TRUE...
/CRAN/refmans/BAT/html/hull.sad.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 3.5K
R: Beta diversity partitioning using convex hull hypervolumes.
...convex hull hypervolumes. Description Pairwise beta diversity partitioning into replacement and net difference in amplitude components of convex hulls. Usage hull.beta(comm, func = "jaccard", comp...
/CRAN/refmans/BAT/html/hull.beta.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 6.0K
R: Sample Points Along a Convex Hull
...a convex hull of the data in order to maintain the positivity identifying assumption. We also provide options to create trimmed versions of the convex hull to further restrict to high density regions...
/CRAN/refmans/mvGPS/html/hull_sample.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 4.2K
R: Concave and convex hulls for LAS objects
...convex hulls for LAS objects Description Concave and convex hulls for LAS objects. st_convex_hull extends sf::st_convex_hull for LAS objects. Both functions return a sfc_POLYGON. concaveman is very...
/CRAN/refmans/lidR/html/st_hull.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 3.7K
R: Build convex hull hypervolumes.
hull.build {BAT} R Documentation Build convex hull hypervolumes. Description Builds convex hull hypervolumes for each community from incidence and trait data. Usage hull.build( comm, trait, distance...
/CRAN/refmans/BAT/html/hull.build.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 4.6K
R: Convex hulls for multiple groups
Hulls {shipunov} R Documentation Convex hulls for multiple groups Description Calculates and plots groups hulls and related information Usage Hulls(pts, groups, match.colors=TRUE, usecolors=NULL, plot...
/CRAN/refmans/shipunov/html/Hulls.html
 cran-help  matching: convex, convex, hull, hull and hull


Size: 2.7K
R: A Generic Convex-Hull-Based Model Selection Method
...Convex-Hull-Based Model Selection Method MultiCHull Convex-Hull-Based Model Selection for multiple Samples multichull A Generic Convex-Hull-Based Model Selection Method MultiCHull.default Convex-Hull-...
/CRAN/refmans/multichull/html/00Index.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Convex Hull
...convex hull EdgesXYZ Edges coordinates hexacosichoron Vertices of the 600-cell hullMesh Mesh of a 3d convex hull hullSummary Summary of 3D convex hull plotConvexHull3d Plot triangulated 3d convex hull...
/CRAN/refmans/cxhull/html/00Index.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Calculate metrics and plotting information for convex hulls
...convex hulls Description This function calculates the area of the convex hull describing a set of bivariate points, and returns other information useful for plotting the hull. Usage siberConvexhull(x...
/CRAN/refmans/SIBER/html/siberConvexhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.9K
R: Find point in intersection of convex hulls
...program similar to the one suggested at ../doc/qhull/html/qhalf.html#notes Usage feasible.point(ch1, ch2, tol = 0) Arguments ch1 First convex hull with normals ch2 Second convex hull with normals tol...
/CRAN/refmans/geometry/html/feasible.point.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.5K
R: Generalization of the Convex Hull of a Sample of Points in the Plane
...-convex hull calculation ahull_track alpha-convex hull calculation of tracking data anglesArc Angles of the extremes of an arc arc Add an arc to a plot areaahull Area of the alpha-convex hull ashape ...
/CRAN/refmans/alphahull/html/00Index.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.3K
R: Points on Convex Hull
...Points on Convex Hull Description Given a set of locations, this function determines which locations belongs to the convex hull (or envelope) of the set. Usage is_chull(x, y) isChull(x, y)...
/CRAN/refmans/swaRm/html/is_chull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Area of the alpha-convex hull
...alpha-convex hull Description This function calculates the area of the \alpha-convex hull of a sample of points. Usage areaahull(x, timeout = 5) Arguments x Object of class "ahull". timeout A numeric...
/CRAN/refmans/alphahull/html/areaahull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.3K
R: Length of the boundary of the alpha-convex hull
...boundary of the alpha-convex hull Description This function calculates the length of the boundary of the \alpha-convex hull of a given sample. Usage lengthahull(ahull.arcs) Arguments ahull.arcs Output...
/CRAN/refmans/alphahull/html/lengthahull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.1K
R: Plots the minimum convex hull of a set of coordinates
...longitudinal values ycoord - Array of y-coordinates or latitudinal values lcolor - String or integer value indicating the color of the convex hull boundary lines Value Plots a minimum convex hull Note...
/CRAN/refmans/GeoRange/html/PlotConvexHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.0K
R: Minimum Convex Hull Polygon
...Convex Hull Polygon Description Generates a minimum convex polygon (MCP; i.e., convex hull) that is delineated from occurrence locality coordinates. This function is a wrapper for 'chull()' that makes...
/CRAN/refmans/changeRangeR/html/mcp.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.8K
R: Convex hull
...convex hull Value A list providing a lot of information about the convex hull. See the README file for details. Examples library(cxhull) points <- rbind( c(0.5,0.5,0.5), c(0,0,0), c(0,0,1), c(0,1,0)...
/CRAN/refmans/cxhull/html/cxhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Drawing the Convex Hull
...of points clr optional colour of points and lines, default black fill Fill the polygon out.rm option to return the outlier removed convex hull Value A "gg" object that draws the plot's convex hull.
/CRAN/refmans/cassowaryr/html/draw_convexhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.5K
R: Convex hull test
...Convex hull test Description Checks if points are in the interior of a convex hull. Usage in.chull(x0, y0, x, y) Arguments x0 coordinates of points to check y0 see x0 x coordinates defining the convex...
/CRAN/refmans/sgeostat/html/in.chull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.1K
R: Convex hull model
Convex Hull {dismo} R Documentation Convex hull model Description The Convex hull model predicts that a species is present at sites inside the convex hull of a set of training points, and absent...
/CRAN/refmans/dismo/html/convHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.5K
R: Does triangle overlap convex hull of points?
...convex hull of points? Description Does triangle overlap convex hull of points? Usage TriangleInHull(triangles, coordinates, buffer) Arguments triangles Three-row matrix as produced by TriangleCentres().
/CRAN/refmans/Ternary/html/TriangleInHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Performs convex hull area calculation from coordinate sets on...
...convex hull area calculation from coordinate sets on the Earth's surface Description Performs convex hull area calculation from coordinate sets on the Earth's surface Usage CHullAreaEarth(longs, lats)...
/CRAN/refmans/GeoRange/html/CHullAreaEarth.html
 cran-help  matching: convex, convex, hull and hull


Size: 4.5K
R: Compute convex hull of intersection of two sets of points
...convex hull of intersection of two sets of points Description Compute convex hull of intersection of two sets of points Usage intersectn( ps1, ps2, tol = 0, return.chs = TRUE, options = "Tv", fp...
/CRAN/refmans/geometry/html/intersectn.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.7K
R: Convex Hull of Polygon
...Convex Hull of Polygon Description Finds the convex hull of a polygon. Note that the function chull (see link below) finds the convex hull of a set of points and is about twice slower than the present...
/CRAN/refmans/tigers/html/chullPolygon.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.4K
R: Convex Hull
...Convex Hull Description Computes the convex hull of a spatial object. Usage convexhull(x) Arguments x a window (object of class "owin"), a point pattern (object of class "ppp"), a line segment pattern...
/CRAN/refmans/spatstat.geom/html/convexhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.0K
R: Compute Convex Hull of a Set of Points
...Compute Convex Hull of a Set of Points Description Computes the subset of points which lie on the convex hull of the set of points specified. Usage chull(x, y = NULL) Arguments x, y coordinate vectors...
/R/refmans/grDevices/html/chull.html
 r-help  matching: convex, convex, hull and hull


Size: 3.0K
R: Get Convex Hull of Points
...the convex hull containing those points. This is a (slightly modified) implementation of the Andrews Monotone Chain, which is a well known algorithm that is able to solve the convex hull with O(nlogn)...
/CRAN/refmans/contoureR/html/getConvexHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.1K
R: Adds convex hulls to each community to an existing plot
plotCommunityHulls {SIBER} R Documentation Adds convex hulls to each community to an existing plot Description This function loops over each community and plots the convex hull based on the centres of...
/CRAN/refmans/SIBER/html/plotCommunityHulls.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.9K
R: Triangles of a triangulated 3D convex hull
...triangulated 3D convex hull Description Coordinates of the vertices of the triangles of a triangulated 3D convex hull. Usage TrianglesXYZ(hull) Arguments hull an output of cxhull applied to 3D points...
/CRAN/refmans/cxhull/html/TrianglesXYZ.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.8K
R: Summary of 3D convex hull
...Summary of 3D convex hull Description Summary of a triangulated 3D convex hull Usage hullSummary(hull) Arguments hull an output of cxhull applied to 3D points and with the option triangulate=TRUE...
/CRAN/refmans/cxhull/html/hullSummary.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.4K
R: A Generic Convex-Hull-Based Model Selection Method
...the convex hull and selects an optimal model by means of the scree test values. Author(s) Marlies Vervloet (marlies.vervloet@kuleuven.be) References Wilderjans, T. F., Ceulemans, E., & Meers, K. (2013).
/CRAN/refmans/multichull/html/multichull-package.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.6K
R: Mesh of a 3d convex hull
...Mesh of a 3d convex hull Description Extract the vertices and the faces from a 3d convex hull. Usage hullMesh(hull, simplify = TRUE, rgl = FALSE) Arguments hull a 3d convex hull, output of cxhull...
/CRAN/refmans/cxhull/html/hullMesh.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Add convex hull for groups of points on scatter plot
...convex hull for groups of points on scatter plot Description The method shows convex hull for groups of points on a scatter plot made using 'mdaplot()' function with 'cgroup' parameter. It will work...
/CRAN/refmans/mdatools/html/plotConvexHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.5K
R: Generalization of the Convex Hull of a Sample of Points in...
...\alpha-convex hull of a given sample of points in the plane. The concepts of \alpha-shape and \alpha-convex hull generalize the definition of the convex hull of a finite set of points. The programming...
/CRAN/refmans/alphahull/html/alphahull-package.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.9K
R: Performs Convex Hull area calculation
CHullArea {GeoRange} R Documentation Performs Convex Hull area calculation Description Performs Convex Hull area calculation Usage CHullArea(longs, lats) Arguments longs - Array of longitudinal...
/CRAN/refmans/GeoRange/html/CHullArea.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.8K
R: Calculate the area of a convex hull given its coordinates
...of a convex hull given its coordinates Description Given the coordinates of a convex hull (i.e. a polygon), this function calculates its area. Not intended for direct use outside of siberConvexhull().
/CRAN/refmans/SIBER/html/hullArea.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.7K
R: Area of the alpha-convex hull
...of the \alpha-convex hull of a sample of points. Usage areaahulleval(x) Arguments x Object of class "ahull". Value area Area of the \alpha-convex hull. See Also ahull. [Package alphahull version 2.5...
/CRAN/refmans/alphahull/html/areaahulleval.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.7K
R: find the maxinum distance from the convex hull formed by the...
...maxinum distance from the convex hull formed by the chosen K vertices Description find the maxinum distance from the convex hull formed by the chosen K vertices Usage getMaxDist(centers, vertex.ind)...
/CRAN/refmans/ScorePlus/html/getMaxDist.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.3K
R: Draws convex hulls around landmark positions
...drawing the convex hull lty an lty for drawing the convex hulls Value a drawing on the last plot See Also coo_chull, chull, ldk_confell, ldk_contour Other plotting functions: coo_arrows(), coo_draw...
/CRAN/refmans/Momocs/html/ldk_chull.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.5K
R: Convex hull features.
feature_chull {tspmeta} R Documentation Convex hull features. Description Determines the area of the convex hull and the ratio of the cities which lie on the convex hull in the euklidean space.
/CRAN/refmans/tspmeta/html/feature_chull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.1K
R: Spherical convex hull.
...Spherical convex hull. Description This function calculates a possible implementation of the spherical convex hull. Usage chullsphere( data, center = c(0, 0, 0), radius = authRadius, param = 200...
/CRAN/refmans/icosa/html/chullsphere.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.4K
R: Edges of a triangulated 3D convex hull
...3D convex hull Description Edges of a triangulated 3D convex hull given by the ids of the vertices in a matrix, plus a column indicating the border edges. Usage EdgesAB(hull) Arguments hull an output...
/CRAN/refmans/cxhull/html/EdgesAB.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.5K
R: Convex Hull of a pointset
convexhull {rsdepth} R Documentation Convex Hull of a pointset Description Convex Hull of a pointset in plane. Usage convexhull(x, y=NULL,...) Arguments x The data as a matrix, data frame or list. If...
/CRAN/refmans/rsdepth/html/convexhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.8K
R: Test if points lie in convex hull
...lie in convex hull Description Tests if a set of points lies within a convex hull, returning a boolean vector in which each element is TRUE if the corresponding point lies within the hull and FALSE if...
/CRAN/refmans/geometry/html/inhulln.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.6K
R: Convex hull vertices
...Convex hull vertices Description The coordinates of the vertices of a 3D convex hull. Usage VerticesXYZ(hull) Arguments hull an output of cxhull applied to 3D points Value A matrix with three columns.
/CRAN/refmans/cxhull/html/VerticesXYZ.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.1K
R: Add confidence ellipse or convex hull for group of points
...confidence ellipse or convex hull for group of points Description Add confidence ellipse or convex hull for group of points Usage plotPointsShape(p, lwd, lty, opacity, shape_function, ...) Arguments p...
/CRAN/refmans/mdatools/html/plotPointsShape.html
 cran-help  matching: convex, convex, hull and hull


Size: 4.1K
R: Calculate Convex Hull Peeling Depth
depth.qhpeeling {ddalpha} R Documentation Calculate Convex Hull Peeling Depth Description Calculates the convex hull peeling depth of points w.r.t. a multivariate data set. Usage depth.qhpeeling(x...
/CRAN/refmans/ddalpha/html/depth.qhpeeling.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.5K
R: Perimeter of the Convex Hull
...Convex Hull Description Given a set of locations, this function determines the perimeter of the convex hull (or envelope) of the set. Usage chull_perimeter(x, y, geo = FALSE) chullPerimeter(x, y, geo...
/CRAN/refmans/swaRm/html/chull_perimeter.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.2K
R: Function which finds the outermost convex hull points after...
...convex hull points after making np samples and finding convex hull for each of them. Description Function which finds the outermost convex hull points after making np samples and finding convex hull...
/CRAN/refmans/archetypal/html/find_outmost_partitioned_convexhull_points.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.4K
R: Checks if AD is within the convex hull of IPD using lp-solve
...AD is within the convex hull of IPD using lp-solve Description Checks if AD is within the convex hull of IPD using lp-solve Usage maicLP(ipd, ad) Arguments ipd a dataframe with n row and p coln, where...
/CRAN/refmans/maicChecks/html/maicLP.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.9K
R: Version of outer which operates only in a convex hull
...operates only in a convex hull Description This version of outer evaluates FUN only on that part of the grid cx x cy that is enclosed within the convex hull of the points (px,py). This can be useful...
/CRAN/refmans/tripack/html/outer.convhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.9K
R: Function which finds the outermost convex hull points in...
...finds the outermost convex hull points in order to be used as initial solution in archetypal analysis Description Function which finds the outermost convex hull points in order to be used as initial...
/CRAN/refmans/archetypal/html/find_outmost_convexhull_points.html
 cran-help  matching: convex, convex, hull and hull


Size: 4.5K
R: Plot the alpha-convex hull
...-convex hull Description This function returns a plot of the \alpha-convex hull. If desired, it also adds the Delaunay triangulation, Voronoi diagram and \alpha-shape of the sample. Usage ## S3 method...
/CRAN/refmans/alphahull/html/plot.ahull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.5K
R: Surface Area of the Convex Hull
...Convex Hull Description Given a set of locations, this function determines the surface area of the convex hull (or envelope) of the set. Usage chull_area(x, y, geo = FALSE) chullArea(x, y, geo = FALSE)...
/CRAN/refmans/swaRm/html/chull_area.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.0K
R: Version of outer which operates only in a convex hull
...outer which operates only in a convex hull Description This version of outer evaluates FUN only on that part of the grid cx times cy that is enclosed within the convex hull of the points (px,py). This...
/CRAN/refmans/interp/html/outer.convhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.9K
R: Plots illustrative convex hulls for each group within all...
...illustrative convex hulls for each group within all communities Description This function loops over each community and group within, and plots a convex hull around the data. N.B. use of convex hulls...
/CRAN/refmans/SIBER/html/plotGroupHulls.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.7K
R: Convex Hull via Andrews Monotone, Rcpp Interface to C++...
...Hull via Andrews Monotone, Rcpp Interface to C++ Routine Description This function is the R interface to the C++ implementation of Andrews Monotone, a well known algorithm for solving the convex hull...
/CRAN/refmans/contoureR/html/convexHullAM.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.8K
R: Plot Convex Hulls of Clusters
...a two-dimensional scatter plot with added convex hulls for clusters. Usage hullplot( x, cl, col = NULL, cex = 0.5, hull_lwd = 1, hull_lty = 1, solid = TRUE, alpha = 0.2, main = "Convex Cluster Hulls", ...
/CRAN/refmans/dbscan/html/hullplot.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.9K
R: Convex Hull of Points
convexhull.xy {spatstat.geom} R Documentation Convex Hull of Points Description Computes the convex hull of a set of points in two dimensions. Usage convexhull.xy(x, y=NULL)...
/CRAN/refmans/spatstat.geom/html/convexhull.xy.html
 cran-help  matching: convex, convex, hull and hull


Size: 4.5K
R: Calculates the (recursive) convex hull of a shape
...convex hull of a shape Description coo_chull returns the ids of points that define the convex hull of a shape. A simple wrapper around chull, mainly used in graphical functions. Usage coo_chull(coo)...
/CRAN/refmans/Momocs/html/coo_chull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.5K
R: Calculate the Convex Hull for a Set of Points
calcConvexHull {PBSmapping} R Documentation Calculate the Convex Hull for a Set of Points Description Calculate the convex hull for a set of points. Usage calcConvexHull (xydata, keepExtra=FALSE)...
/CRAN/refmans/PBSmapping/html/calcConvexHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 5.0K
R: Intersection between convex hulls of pairs of sites
...convex hulls of all pairs of sites (including self-intersection, which corresponds to their convex hull). Note that when standardizing convex hulls of intersections, this function uses the convex hull...
/CRAN/refmans/fundiversity/html/fd_fric_intersect.html
 cran-help  matching: convex, convex, hull and hull


Size: 7.0K
R: alpha-convex hull calculation
...alpha-convex hull calculation Description This function calculates the \alpha-convex hull of a given sample of points in the plane for \alpha>0. Usage ahull(x, y = NULL, alpha) Arguments x, y The x...
/CRAN/refmans/alphahull/html/ahull.html
 cran-help  matching: convex, convex, hull and hull


Size: 4.3K
R: Identify the position of a point relative to the convex hull...
...of the convex hull of rows of M. If p is a matrix, a value that scales all rows of p into the convex hull of M is found. Usage shrink_into_CH( p, M, m = NULL, verbose = FALSE, ..., solver = c("glpk"...
/CRAN/refmans/ergm/html/shrink_into_CH.html
 cran-help  matching: convex, convex, hull and hull


Size: 6.0K
R: Generation of Uniform Points in the Convex Hull of Points
runif.multi.tri {pcds} R Documentation Generation of Uniform Points in the Convex Hull of Points Description An object of class "Uniform". Generates n points uniformly in the Convex Hull of set of...
/CRAN/refmans/pcds/html/runif.multi.tri.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.9K
R: SDM-based Minimum Convex Hull Polygon
...of species threat level by delineating a minimum convex polygon (i.e., convex hull) around a thresholded SDM prediction, first described by Syfert et al. (2014) <doi:10.1016/j.biocon.2014.06.012>.
/CRAN/refmans/changeRangeR/html/mcpSDM.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.6K
R: Convert Tropical Linear Space to Convex Hull
linsp_to_poly {Rtropical} R Documentation Convert Tropical Linear Space to Convex Hull Description Convert Tropical Linear Space to Convex Hull Usage linsp_to_poly(V) Arguments V a data matrix, of...
/CRAN/refmans/Rtropical/html/linsp_to_poly.html
 cran-help  matching: convex, convex, hull and hull


Size: 1.5K
R: Compute coordinates of a closed convex hull for data points
getConvexHull {mdatools} R Documentation Compute coordinates of a closed convex hull for data points Description Compute coordinates of a closed convex hull for data points Usage getConvexHull(points)...
/CRAN/refmans/mdatools/html/getConvexHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.0K
R: Raster mask of convex hull
raster_chull_mask {lidaRtRee} R Documentation Raster mask of convex hull Description creates raster mask corresponding to the convex hull of xy positions Usage raster_chull_mask(xy...
/CRAN/refmans/lidaRtRee/html/raster_chull_mask.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Calculate Convex Hull Compactness
comp_ch {redistmetrics} R Documentation Calculate Convex Hull Compactness Description Calculate Convex Hull Compactness Usage comp_ch(plans, shp, epsg = 3857, ncores = 1) Arguments plans A redist_plans...
/CRAN/refmans/redistmetrics/html/comp_ch.html
 cran-help  matching: convex, convex, hull and hull


Size: 6.5K
R: Function which finds the outermost projected convex hull...
...finds the outermost projected convex hull points in order to be used as initial solution in archetypal analysis Description Function which finds the outermost projected convex hull points in order to...
/CRAN/refmans/archetypal/html/find_outmost_projected_convexhull_points.html
 cran-help  matching: convex, convex, hull and hull


Size: 6.4K
R: Compute smallest convex hull that encloses a set of points
...Compute smallest convex hull that encloses a set of points Description Returns information about the smallest convex complex of a set of input points in N-dimensional space (the convex hull of the...
/CRAN/refmans/geometry/html/convhulln.html
 cran-help  matching: convex, convex, hull and hull


Size: 5.2K
R: Efficient test for points inside a convex hull in p...
...a convex hull in p dimensions. Description Efficient test for points inside a convex hull in p dimensions. Usage inHull( pts, vertices, hull = NULL, tol = mean(mean(abs(as.matrix(vertices)))) * sqrt...
/CRAN/refmans/gMOIP/html/inHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 2.2K
R: Convex hull, minimal bounding rotated rectangle, and minimal...
...Convex hull, minimal bounding rotated rectangle, and minimal bounding circle Description Get the convex hull, the minimal bounding rotated rectangle, or minimal bounding circle of a SpatVector...
/CRAN/refmans/terra/html/convhull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.5K
R: Search for the enclosing Delaunay convex hull
...convex hull Description For t <- delaunay(cbind(x, y)), where (x, y) is a 2D set of points, tsearch(x, y, t, xi, yi) finds the index in t containing the points (xi, yi). For points outside the convex...
/CRAN/refmans/geometry/html/tsearch.html
 cran-help  matching: convex, convex, hull and hull


Size: 5.1K
R: Complement of the alpha-convex hull
complement {alphahull} R Documentation Complement of the alpha-convex hull Description This function calculates the complement of the \alpha-convex hull of a given sample for \alpha>0. Usage complement...
/CRAN/refmans/alphahull/html/complement.html
 cran-help  matching: convex, convex, hull and hull


Size: 6.2K
R: A Generic Convex-Hull-Based Model Selection Method
...determines the models that are located on the boundary of the convex hull and selects an optimal model by means of the scree test values. Usage CHull(data, bound = "lower", PercentageFit = 0.01) ## S3...
/CRAN/refmans/multichull/html/CHull.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.7K
R: Search for the enclosing Delaunay convex hull
...convex hull Description For t = delaunayn(x), where x is a set of points in N dimensions, tsearchn(x, t, xi) finds the index in t containing the points xi. For points outside the convex hull, idx is...
/CRAN/refmans/geometry/html/tsearchn.html
 cran-help  matching: convex, convex, hull and hull


Size: 5.3K
R: Plot triangulated 3d convex hull
...3d convex hull Description Plot a triangulated 3d convex hull with rgl. Usage plotConvexHull3d( hull, angleThreshold = NULL, edgesAsTubes = TRUE, verticesAsSpheres = TRUE, palette = NULL, bias = 1...
/CRAN/refmans/cxhull/html/plotConvexHull3d.html
 cran-help  matching: convex, convex, hull and hull


Size: 4.1K
R: alpha-convex hull calculation of tracking data
...alpha-convex hull calculation of tracking data Description This function approximates the \alpha-convex hull of tracking data and returns a list of geom_path objects of the boundary. Usage ahull_track...
/CRAN/refmans/alphahull/html/ahull_track.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.2K
R: Checks if AD is within the convex hull of IPD using...
...Checks if AD is within the convex hull of IPD using Mahalanobis distance Description Should only be used when all matching variables are normally distributed Usage maicMD(ipd, ad, n.ad = Inf)...
/CRAN/refmans/maicChecks/html/maicMD.html
 cran-help  matching: convex, convex, hull and hull


Size: 4.7K
R: Update Plots with Convex Hulls for Groups
shapeHulls {geomorph} R Documentation Update Plots with Convex Hulls for Groups Description This function is used to update plot.procD.lm and plot.gm.prcomp ordination plot objects with convex hulls...
/CRAN/refmans/geomorph/html/shapeHulls.html
 cran-help  matching: convex, convex, hull and hull


Size: 3.5K
R: Convex Hull procedure
DimSelector {ThreeWay} R Documentation Convex Hull procedure Description Selects among three-mode principal component models of different complexities. Usage DimSelector(out, n, m, p, model)...
/CRAN/refmans/ThreeWay/html/DimSelector.html
 cran-help  matching: convex, convex, hull and hull




powered by xapian
hosted and maintained by the Institute for Statistics and Mathematics
of WU (Vienna University of Economics and Business)
give a feedback