分享

收藏·空间计量R代码及书单资源推荐

 晶晶晶晶323 2020-07-25

1

空间计量及R书单

1、Luc Anselin (2005)Spatial Regression Analysis in R-A Workbook

2、Reinhold Kosfeld(2016),Spatial Econometrics with R-Spatial Data Analysis of the 5-Region Script Example

3、Arbia(2014),《A Primer for Spatial Econometrics: With Applications in R》

4、Kelejian et al.(2017),《Spatial Econometrics》

5、McMillen (2012),《Quantile Regression for Spatial Data》

6、《区域经济研究实用方法:基于ArcGIS,GeoDa和R的运用》,王庆喜著

7、《空间计量经济学入门:在R中的应用:with applications in R》

8、更多空间计量及R相关书单,欢迎补充!

2

空间计量及R代码

来源:https://cran./web/views/Spatial.html

版本:2020-06-16

URL: https://cran./view=spatial

Base R包括许多可用于读取、可视化和分析空间数据的函数。这一观点的重点是“地理”空间数据,在这些数据中,观察可以与地理位置相识别,如果仔细记录位置,则可以检索关于这些位置的附加信息。

基本函数由软件包补充,其中一些在CRAN上,其他的仍在开发中。其中一个位置是Github。

贡献的包涉及两个广泛的领域:将空间数据移入和移出R,以及在R中分析空间数据。

有许多贡献的教程和介绍;最近的一个是由Robin Lovelace和James Cheshire写的《Introduction to visualising spatial data in R》。

用于空间数据和元数据的类

由于许多导入和使用空间数据的包必须包含存储数据的对象和可视化数据的函数,因此正在着手构建用于空间数据的共享类和绘图函数。

正在进行补充活动,以支持更好地处理R中的地理元数据。

Spatial data - general

  • The sp package provides classes and methods for dealing with spatial data and is discussed in a note in R News .

  • sf is a newer package now on CRAN, and is being actively developed here: sf, providing Simple Features for R, in compliance with the OGC Simple Feature standard. The development of the package is being supported by the R Consortium . It provides simple features access for vector data, and as such is a modern implementation and standardization of parts of sp. It is documented in an R Journal article.

  • stars is being actively developed here: stars, and supported by the R Consortium ; it provides for spatiotemporal data in the form of dense arrays.

  • stplanr provides a 'SpatialLinesNetwork' class based on objects defined in sp and igraph that can be used for routing analysis within R. Another network package is shp2graph.

  • The spacetime package extends the shared classes defined in sp for spatio-temporal data (see Spatio-Temporal Data in R ).

  • inlmisc has followed on from Grid2Polygons and converts a spatial object from class SpatialGridDataFrame to SpatialPolygonsDataFrame among many other possibilities.

  • maptools provides conversion functions between PBSmapping and spatstat and sp classes, in addition to maps databases and sp classes.

Raster data

  • raster package is a major extension of sp spatial data classes to virtualise access to large rasters, permitting large objects to be analysed, and extending the analytical tools available for both raster and vector data. Used with rasterVis, it can also provide enhanced visualisation and interaction.

  • stars provides for spatiotemporal data in the form of dense arrays, with space and time being array dimensions. Examples include socio-economic or demographic data, environmental variables monitored at fixed stations, time series of satellite images with multiple spectral bands, spatial simulations, and climate model results.

Geographic metadata

  • geometa provides classes and methods to write geographic metadata following the ISO and OGC metadata standards (ISO 19115, 19110, 19119) and export it as XML (ISO 19139) for later publication into metadata catalogues. Reverserly, geometa provides a way to read ISO 19139 metadata into R. The package extends sf to provide GML (ISO 19136) representation of geometries. geometa is under active development on geometa

  • ncdf4 provides read and write functions for handling metadata (CF conventions) in the self-described NetXDF format.

Reading and writing spatial data

Reading and writing spatial data - rgdal

Maps may be vector-based or raster-based. The rgdal package provides bindings to GDAL (Geospatial Data Abstraction Library) -supported raster formats and OGR -supported vector formats. It contains functions to write raster and vector files in supported formats. Formats supported by GDAL/OGR include both OGC standard data formats (e.g. GeoJSON) and proprietary formats (e.g. ESRI Shapefile). The package also provides PROJ.4 projection support for vector objects ( this site provides searchable online PROJ.4 representations of projections). Affine and similarity transformations on sp objects may be made using functions in the vec2dtransf package. The Windows and Mac OSX CRAN binaries of rgdal include subsets of possible data source drivers; if others are needed, use other conversion utilities, or install from source against a version of GDAL with the required drivers.

Reading and writing spatial data - data formats

Other packages provide facilities to read and write spatial data, dealing with open standard formats or proprietary formats.

OGC Standard Data formats

  • Well-Known Text (WKT) / Well-Known Binary (WKB): These standards are part of the OGC Simple Feature specification. Both WKT/WKB formats are supported by sf package that implements the whole OGC Simple Feature specification in R. Apart from the sf package, the rgeos package provides functions for reading and writing well-known text (WKT) geometry. Package wkb package provides functions for reading and writing well-known binary (WKB) geometry.

  • GeoJSON: An rOpenSci blog entry described a GeoJSON-centred approach to reading GeoJSON and WKT data. GeoJSON can be written and read using rgdal, and WKT by rgeos. The entry lists geojson, geojsonio, geoaxe and lawn among others.

  • Geographic Markup Language (GML): GML format can be read and writen with rgdal. Additional GML native reader and writer is provided by geometa model with bindings to the sf classes, for extension of geographic metadata with GML data and metadata elements (GML 3.2.1 and 3.3) and interfacing OGC web-services in ows4R package

  • NetCDF files: ncdf4 or RNetCDF may be used.

Proprietary Data Formats

  • ESRI formats: maps (with mapdata and mapproj) provides access to the same kinds of geographical databases as S. maptools and shapefiles read and write ESRI ArcGIS/ArcView shapefiles.

  • Others: maptools package provides helper functions for writing map polygon files to be read by WinBUGS Mondrian , and the tmap command in Stata . The gmt package gives a simple interface between GMT map-making software and R.

Reading and writing spatial data - GIS Software connectors

  • PostGIS: The rpostgis package provides additional functions to the RPostgreSQL package to interface R with a 'PostGIS'-enabled database, as well as convenient wrappers to common 'PostgreSQL' queries. It is documented in an R Journal article. postGIStools package provides functions to convert geometry and 'hstore' data types from 'PostgreSQL' into standard R objects, as well as to simplify the import of R data frames (including spatial data frames) into 'PostgreSQL'. sf also provides an R interface to Postgis, for both reading and writing, throuh GDAL.

  • GRASS: Integration with version 7.* of the leading open source GIS, GRASS, is provided in CRAN package rgrass7, using rgdal for exchanging data. For GRASS 6.*, use spgrass6.

  • SAGA: RSAGA is a similar shell-based wrapper for SAGA commands.

  • Quantum GIS (QGIS): QGIS2 was supported by RQGIS. QGIS3 is supported by RQGIS3, which establishes an interface between R and QGIS, i.e. it allows the user to access QGIS functionalities from the R console. It achieves this by using the QGIS Python API.

  • ArcGIS: RPyGeo is a wrapper for Python access to the ArcGIS GeoProcessor

Interfaces to Spatial Web-Services

Some R packages focused on providing interfaces to web-services and web tools in support of spatial data management. Here follows a first tentative (non-exhaustive) list:

  • ows4R is a new package that intends to provide an R interface to OGC standard Web-Services. It is in active development at ows4R and currently support interfaces to the Web Feature Service (WFS) for vector data access, with binding to the sf package, and the Catalogue Service (CSW) for geographic metadata discovery and management (including transactions), with binding to the geometa package.

  • geosapi is an R client for the GeoServer REST API, an open source implementation used widely for serving spatial data.

  • geonapi provides an interface to the GeoNetwork legacy API, an opensource catalogue for managing geographic metadata.

Specific geospatial data sources of interest

  • rnaturalearth package facilitates interaction with Natural Earth map data. It includes functions to download a wealth of Natural Earth vector and raster data, including cultural (e.g., country boundaries, airports, roads, railroads) and physical (e.g., coastline, lakes, glaciates areas) datasets.

  • Modern country boundaries are provided at 2 resolutions by rworldmap along with functions to join and map tabular data referenced by country names or codes. Chloropleth and bubble maps are supported and general functions to work on user supplied maps (see A New R package for Mapping Global Data . Higher resolution country borders are available from the linked package rworldxtra. Historical country boundaries (1946-2012) can be obtained from the cshapes.

  • marmap package is designed for downloading, plotting and manipulating bathymetric and topographic data in R. It allows to query the ETOPO1 bathymetry and topography database hosted by the NOAA, use simple latitude-longitude-depth data in ascii format, and take advantage of the advanced plotting tools available in R to build publication-quality bathymetric maps (see the PLOS paper).

  • maptools provides an interface to GSHHS shoreline databases.

  • The UScensus2000 suite of packages (UScensus2000cdp, UScensus2000tract) makes the use of data from the 2000 US Census more convenient. An important data set, Guerry's 'Moral Statistics of France', has been made available in the Guerry package, which provides data and maps and examples designed to contribute to the integration of multivariate and spatial analysis.

  • rgbif package is used to access Global Biodiversity Information Facility (GBIF) occurence data

  • geonames is an interface to the www.geonames.org service.

  • OpenStreetMap gives access to open street map raster images, and osmar provides infrastructure to access OpenStreetMap data from different sources, to work with the data in common R manner, and to convert data into available infrastructure provided by existing R packages.

  • tidycensus provides access to US Census Bureau data in a tidy format, including the option to bind the data spatially on import.

  • tigris provides access to cartographic elements provided by the US Census Bureau TIGER, including cartographic boundaries, roads, and water.

Handling spatial data

A number of packages dedicated to spatial data handling have been written using sp classes.

Data processing - general

  • rgdal and maptools. The rgeos package provides an interface to topology functions for sp objects using GEOS .

  • raster package introduces many GIS methods that now permit much to be done with spatial data without having to use GIS in addition to R.

  • The gdalUtils package provides wrappers for the Geospatial Data Abstraction Library (GDAL) Utilities.

  • gdistance, provides functions to calculate distances and routes on geographic grids. geosphere permits computations of distance and area to be carried out on spatial data in geographical coordinates. cshapes package provides functions for calculating distance matrices (see Mapping and Measuring Country Shapes ).

  • spsurvey provides a range of sampling functions.

  • The trip package extends sp classes to permit the accessing and manipulating of spatial data for animal tracking.

  • spcosa provides spatial coverage sampling and random sampling from compact geographical strata.

  • magclass offers a data class for increased interoperability working with spatial-temporal data together with corresponding functions and methods (conversions, basic calculations and basic data manipulation). The class distinguishes between spatial, temporal and other dimensions to facilitate the development and interoperability of tools build for it. Additional features are name-based addressing of data and internal consistency checks (e.g. checking for the right data order in calculations).

  • taRifx is a collection of utility and convenience functions, and some interesting spatial functions.

  • geoaxe allows users to split 'geospatial' objects into pieces.

  • The lawn package is a client for 'Turfjs' for 'geospatial'analysis.

  • The areal package can be used to interpolate overlapping but incongruent polygons, also known as areal weighted interpolation.

  • The qualmap package can be used to digitize qualitative GIS data.

Data processing - raster and imagery data

  • The landsat package with accompanying JSS paper provides tools for exploring and developing correction tools for remote sensing data.

Data cleaning

  • cleangeo may be used to inspect spatial objects, facilitate handling and reporting of topology errors and geometry validity issues. It may be used to reduce the likelihood of having issues when doing spatial data processing.

  • lwgeom may also be used to facilitate handling and reporting of topology errors and geometry validity issues.

Visualizing spatial data

Base visualization packages

  • Packages such as sp, sf, raster and rasterVis provide basic visualization methods through the generic plot function

  • RColorBrewer provides very useful colour palettes that may be modified or extended using the colorRampPalette function provided with R.

  • viridis also provides colour palettes designed with consideration for colorblindness and printing in grayscale.

  • classInt package provides functions for choosing class intervals for thematic cartography.

Thematic cartography packages

  • tmap package provides a modern basis for thematic mapping optionally using a Grammar of Graphics syntax. Because it has a custom grid graphics platform, it obviates the need to fortify geometries to use with ggplot2.

  • quickmapr provides a simple method to visualize 'sp' and 'raster' objects, allows for basic zooming, panning, identifying, and labeling of spatial objects, and does not require that the data be in geographic coordinates.

  • cartography package allows various cartographic representations such as proportional symbols, choropleth, typology, flows or discontinuities.

  • Additional processing and mapping functions are available in PBSmapping package; PBSmodelling provides modelling support. In addition, GEOmap provides mapping facilities directed to meet the needs of geologists, and uses the geomapdata package.

Packages based on web-mapping frameworks

  • mapview, leaflet and leafletR packages provide methods to view spatial objects interactively, usually on a web mapping base.

  • RgoogleMaps package for accessing Google Maps(TM) may be useful if the user wishes to place a map backdrop behind other displays.

  • plotKML is a package providing methods for the visualisation of spatial and spatio-temporal objects in Google Earth.

  • ggmap may be used for spatial visualisation with Google Maps and OpenStreetMap; ggsn provides North arrows and scales for such maps.

  • mapedit provides an R shiny widget based on leaflet for editing or creating sf geometries.

Building Cartograms

  • The micromap package provides linked micromaps using ggplot2.

  • recmap package provides rectangular cartograms with rectangle sizes reflecting for example population.

  • statebins provides a simpler binning approach to US states.

  • cartogram package allows for constructions of a continuous area cartogram by a rubber sheet distortion algorithm, non-contiguous Area Cartograms, and non-overlapping Circles Cartogram.

  • geogrid package turns polygons into rectangular or hexagonal cartograms.

Analyzing spatial data

Point pattern analysis

The spatial package is a recommended package shipped with base R, and contains several core functions, including an implementation of Khat by its author, Prof. Ripley. In addition, spatstat allows freedom in defining the region(s) of interest, and makes extensions to marked processes and spatial covariates. Its strengths are model-fitting and simulation, and it has a useful homepage . It is the only package that will enable the user to fit inhomogeneous point process models with interpoint interactions. The spatgraphs package provides graphs, graph visualisation and graph based summaries to be used with spatial point pattern analysis. The splancs package also allows point data to be analysed within a polygonal region of interest, and covers many methods, including 2D kernel densities. The smacpod package provides various statistical methods for analyzing case-control point data. The methods available closely follow those in chapter 6 of Applied Spatial Statistics for Public Health Data by Waller and Gotway (2004).

ecespa provides wrappers, functions and data for spatial point pattern analysis, used in the book on Spatial Ecology of the ECESPA/AEET. The functions for binning points on grids in ash may also be of interest. The aspace package is a collection of functions for estimating centrographic statistics and computational geometries from spatial point patterns. DSpat contains functions for spatial modelling for distance sampling data and spatialsegregation provides segregation measures for multitype spatial point patterns. GriegSmith uses the Grieg-Smith method on 2 dimensional spatial data. The dbmss package allows simple computation of a full set of spatial statistic functions of distance, including classical ones (Ripley's K and others) and more recent ones used by spatial economists (Duranton and Overman's Kd, Marcon and Puech's M). It relies on spatstat for core calculation.

Geostatistics

The gstat package provides a wide range of functions for univariate and multivariate geostatistics, also for larger datasets, while geoR contains functions for model-based geostatistics. Variogram diagnostics may be carried out with vardiag. Automated interpolation using gstat is available in automap. This family of packages is supplemented by intamap with procedures for automated interpolation. A similar wide range of functions is to be found in the fields package. The spatial package is shipped with base R, and contains several core functions. The spBayes package fits Gaussian univariate and multivariate models with MCMC. ramps is a different Bayesian geostatistical modelling package. The geospt package contains some geostatistical and radial basis functions, including prediction and cross validation. Besides, it includes functions for the design of optimal spatial sampling networks based on geostatistical modelling. spsann is another package to offer functions to optimize sample configurations, using spatial simulated annealing. The FRK package is a tool for spatial/spatio-temporal modelling and prediction with large datasets. The approach, discussed in Cressie and Johannesson (2008), decomposes the field, and hence the covariance function, using a fixed set of n basis functions, where n is typically much smaller than the number of data points (or polygons) m.

The RandomFields package provides functions for the simulation and analysis of random fields, and variogram model descriptions can be passed between geoR, gstat and this package. In addition, CompRandFld, constrainedKriging and geospt provide alternative approaches to geostatistical modelling. The spTimer package is able to fit, spatially predict and temporally forecast large amounts of space-time data using [1] Bayesian Gaussian Process (GP) Models, [2] Bayesian Auto-Regressive (AR) Models, and [3] Bayesian Gaussian Predictive Processes (GPP) based AR Models. The rtop package provides functions for the geostatistical interpolation of data with irregular spatial support such as runoff related data or data from administrative units. The georob package provides functions for fitting linear models with spatially correlated errors by robust and Gaussian Restricted Maximum Likelihood and for computing robust and customary point and block kriging predictions, along with utility functions for cross-validation and for unbiased back-transformation of kriging predictions of log-transformed data. The SpatialTools package has an emphasis on kriging, and provides functions for prediction and simulation. It is extended by ExceedanceTools, which provides tools for constructing confidence regions for exceedance regions and contour lines. The sperrorest package implements spatial error estimation and permutation-based spatial variable importance using different spatial cross-validation and spatial block bootstrap methods. The spm package provides functions for hybrid geostatistical and machine learning methods for spatial predictive modelling. It currently contains two commonly used geostatistical methods, two machine learning methods, four hybrid methods and two averaging methods.

The sgeostat package is also available. Within the same general topical area are the deldir and tripack packages for triangulation and the akima package for spline interpolation; the MBA package provides scattered data interpolation with multilevel B-splines. In addition, there are the spatialCovariance package, which supports the computation of spatial covariance matrices for data on rectangles and the tgp package. The Stem package provides for the estimation of the parameters of a spatio-temporal model using the EM algorithm, and the estimation of the parameter standard errors using a spatio-temporal parametric bootstrap. FieldSim is another random fields simulations package. The SSN is for geostatistical modeling for data on stream networks, including models based on in-stream distance. Models are created using moving average constructions. Spatial linear models, including covariates, can be fit with ML or REML. Mapping and other graphical functions are included. The ipdw provides functions o interpolate georeferenced point data via Inverse Path Distance Weighting. Useful for coastal marine applications where barriers in the landscape preclude interpolation with Euclidean distances. RSurvey may be used as a processing program for spatially distributed data, and is capable of error corrections and data visualisation.

Disease mapping and areal data analysis

DCluster is a package for the detection of spatial clusters of diseases. It extends and depends on the spdep package, which provides basic functions for building neighbour lists and spatial weights, tests for spatial autocorrelation for areal data like Moran's I. Functions for fitting spatial regression models, such as SAR and CAR models prior to version 1.1-1 are now in spatialreg. These models assume that the spatial dependence can be described by known weights. In spatialreg, the ME and SpatialFiltering functions provide Moran Eigenvector model fitting, as do more modern functions in the spmoran package. The SpatialEpi package provides implementations of cluster detection and disease mapping functions, including Bayesian cluster detection, and supports strata. The smerc package provides statistical methods for the analysis of data areal data, with a focus on cluster detection. Regionalisation of polygon objects is provided by AMOEBA: a function to calculate spatial clusters using the Getis-Ord local statistic. It searches irregular clusters (ecotopes) on a map, and by skater in spdep. The seg package provides functions for measuring spatial segregation. The spgwr package contains an implementation of geographically weighted regression methods for exploring possible non-stationarity. The gwrr package fits geographically weighted regression (GWR) models and has tools to diagnose and remediate collinearity in the GWR models. Also fits geographically weighted ridge regression (GWRR) and geographically weighted lasso (GWL) models. The GWmodel package contains functions for computing geographically weighted (GW) models. Specifically, basic, robust, local ridge, heteroskedastic, mixed, multiscale, generalised and space-time GWR; GW summary statistics, GW PCA and GW discriminant analysis; associated tests and diagnostics; and options for a range of distance metrics. The sparr package provides another approach to relative risks. The CARBayes package implements Bayesian hierarchical spatial areal unit models. In such models, the spatial correlation is modelled by a set of random effects, which are assigned a conditional autoregressive (CAR) prior distribution. Examples of the models included are the BYM model as well as a recently developed localised spatial smoothing model. The spaMM package fits spatial GLMMs, using the Matern correlation function as the basic model for spatial random effects. The PReMiuM package is for profile regression, which is a Dirichlet process Bayesian clustering model; it provides a spatial CAR term that can be included in the fixed effects (which are global, ie. non-cluster specific, parameters) to account for any spatial correlation in the residuals. Spatial survival analysis is provided by the spatsurv - Bayesian inference for parametric proportional hazards spatial survival models - and spBayesSurv - Bayesian Modeling and Analysis of Spatially Correlated Survival Data - packages. The spselect package provides modelling functions based on forward stepwise regression, incremental forward stagewise regression, least angle regression (LARS), and lasso models for selecting the spatial scale of covariates in regression models.

Spatial regression

The choice of function for spatial regression will depend on the support available. If the data are characterised by point support and the spatial process is continuous, geostatistical methods may be used, or functions in the nlme package. If the support is areal, and the spatial process is not being treated as continuous, functions provided in the spatialreg package may be used. This package can also be seen as providing spatial econometrics functions, and, as noted above, provides basic functions for building neighbour lists and spatial weights, tests for spatial autocorrelation for areal data like Moran's I, and functions for fitting spatial regression models. spdep provides the full range of local indicators of spatial association, such as local Moran's I and diagnostic tools for fitted linear models, including Lagrange Multiplier tests. Spatial regression models that can be fitted using maximum likelihood and Bayesian MCMC methods in spatialreg include spatial lag models, spatial error models, and spatial Durbin models. For larger data sets, sparse matrix techniques can be used for maximum likelihood fits, while spatial two-stage least squares and generalised method of moments estimators are an alternative. When using GMM, sphet can be used to accommodate both autocorrelation and heteroskedasticity. The McSpatial provides functions for locally weighted regression, semiparametric and conditionally parametric regression, fourier and cubic spline functions, GMM and linearized spatial logit and probit, k-density functions and counterfactuals, nonparametric quantile regression and conditional density functions, Machado-Mata decomposition for quantile regressions, spatial AR model, repeat sales models, and conditionally parametric logit and probit. The splm package provides methods for fitting spatial panel data by maximum likelihood and GM. The two small packages S2sls and spanel provide alternative implementations without most of the facilities of splm. spatialprobit make possible Bayesian estimation of the spatial autoregressive probit model (SAR probit model). The starma package provides functions to identify, estimate and diagnose a Space-Time AutoRegressive Moving Average (STARMA) model.

Ecological analysis

There are many packages for analysing ecological and environmental data. They include:

  • ade4 for exploratory and Euclidean methods in the environmental sciences, the adehabitat family of packages for the analysis of habitat selection by animals (adehabitatHR, adehabitatHS, adehabitatLT, and adehabitatMA)

  • pastecs for the regulation, decomposition and analysis of space-time series

  • vegan for ordination methods and other useful functions for community and vegetation ecologists, and many other functions in other contributed packages. One such is tripEstimation, basing on the classes provided by trip. ncf has entered CRAN recently, and provides a range of spatial nonparametric covariance functions.

  • The spind package provides functions for spatial methods based on generalized estimating equations (GEE) and wavelet-revised methods (WRM), functions for scaling by wavelet multiresolution regression (WMRR), conducting multi-model inference, and stepwise model selection.

  • rangeMapper is a package to manipulate species range (extent-of-occurrence) maps, mainly tools for easy generation of biodiversity (species richness) or life-history traits maps.

  • The siplab package is a platform for experimenting with spatially explicit individual-based vegetation models.

  • ModelMap builds on other packages to create models using underlying GIS data.

  • The SpatialPosition computes spatial position models: Stewart potentials, Reilly catchment areas, Huff catchment areas.

  • The Watersheds package provides methods for watersheds aggregation and spatial drainage network analysis.

  • Rcitrus (off-CRAN package) is for the spatial analysis of plant disease incidence.

  • The ngspatial package provides tools for analyzing spatial data, especially non-Gaussian areal data. It supports the sparse spatial generalized linear mixed model of Hughes and Haran (2013) and the centered autologistic model of Caragea and Kaiser (2009).

  • landscapemetrics package calculates landscape metrics for categorical landscape patterns. It can be used as a drop-in replacement for FRAGSTATS , as it offers a reproducible workflow for landscape analysis in a single environment. It also provides several visualization functions, e.g. to show all labeled patches or the core area of all patches.

The Environmetrics Task View contains a much more complete survey of relevant functions and packages.

CRAN packages:

  • ade4

  • adehabitatHR

  • adehabitatHS

  • adehabitatLT

  • adehabitatMA

  • akima

  • AMOEBA

  • areal

  • ash

  • aspace

  • automap

  • CARBayes

  • cartogram

  • cartography

  • classInt (core)

  • cleangeo

  • CompRandFld

  • constrainedKriging

  • cshapes

  • dbmss

  • DCluster (core)

  • deldir (core)

  • DSpat

  • ecespa

  • ExceedanceTools

  • fields

  • FieldSim

  • FRK

  • gdalUtils

  • gdistance

  • geoaxe

  • geogrid

  • geojson

  • geojsonio

  • GEOmap

  • geomapdata

  • geometa

  • geonames

  • geonapi

  • geoR (core)

  • georob

  • geosapi

  • geosphere

  • geospt

  • ggmap

  • ggsn

  • gmt

  • GriegSmith

  • gstat (core)

  • Guerry

  • GWmodel

  • gwrr

  • igraph

  • inlmisc

  • intamap

  • ipdw

  • landsat

  • landscapemetrics

  • lawn

  • leaflet

  • leafletR

  • lwgeom

  • magclass

  • mapdata

  • mapedit

  • mapproj

  • maps

  • maptools (core)

  • mapview

  • marmap

  • MBA

  • McSpatial

  • micromap

  • ModelMap

  • ncdf4

  • ncf

  • ngspatial

  • nlme

  • OpenStreetMap

  • osmar

  • ows4R

  • pastecs

  • PBSmapping

  • PBSmodelling

  • plotKML

  • postGIStools

  • PReMiuM

  • qualmap

  • quickmapr

  • ramps

  • RandomFields (core)

  • rangeMapper

  • raster (core)

  • rasterVis

  • RColorBrewer (core)

  • recmap

  • rgbif

  • rgdal (core)

  • rgeos (core)

  • RgoogleMaps

  • rgrass7

  • rnaturalearth

  • RNetCDF

  • rpostgis

  • RPostgreSQL

  • RPyGeo

  • RSAGA

  • RSurvey

  • rtop

  • rworldmap

  • rworldxtra

  • S2sls

  • seg

  • sf (core)

  • sgeostat

  • shapefiles

  • shp2graph

  • siplab

  • smacpod

  • smerc

  • sp (core)

  • spacetime (core)

  • spaMM

  • spanel

  • sparr

  • spatgraphs

  • spatial

  • spatialCovariance

  • SpatialEpi

  • SpatialPosition

  • spatialprobit

  • spatialreg (core)

  • spatialsegregation

  • SpatialTools

  • spatstat (core)

  • spatsurv

  • spBayes

  • spBayesSurv

  • spcosa

  • spdep (core)

  • sperrorest

  • spgrass6

  • spgwr

  • sphet

  • spind

  • splancs (core)

  • splm

  • spm

  • spmoran

  • spsann

  • spselect

  • spsurvey

  • spTimer

  • SSN

  • starma

  • stars

  • statebins

  • Stem

  • stplanr

  • taRifx

  • tgp

  • tidycensus

  • tigris

  • tmap

  • trip

  • tripack

  • tripEstimation

  • UScensus2000cdp

  • UScensus2000tract

  • vardiag

  • vec2dtransf

  • vegan

  • viridis

  • Watersheds

  • wkb

Related links:

  • CRAN Task View: SpatioTemporal

  • CRAN Task View: Environmetrics

  • R-SIG-Geo mailing list

    本站是提供个人知识管理的网络存储空间,所有内容均由用户发布,不代表本站观点。请注意甄别内容中的联系方式、诱导购买等信息,谨防诈骗。如发现有害或侵权内容,请点击一键举报。
    转藏 分享 献花(0

    0条评论

    发表

    请遵守用户 评论公约

    类似文章 更多